[SCM] Gerris Flow Solver branch, upstream, updated. b3aa46814a06c9cb2912790b23916ffb44f1f203

Stephane Popinet s.popinet at niwa.co.nz
Fri May 15 02:51:51 UTC 2009


The following commit has been merged in the upstream branch:
commit 545230a47b4835e975d72f04bfdddb12a550b498
Author: Stephane Popinet <s.popinet at niwa.co.nz>
Date:   Fri May 27 08:24:10 2005 +1000

    Restructured advection order test cases
    
    darcs-hash:20050526222410-fbd8f-4bf6047281c363acc51a2cf3e84e56679105bd08.gz

diff --git a/test/advection/Makefile.am b/test/advection/Makefile.am
index d552f24..0edc1ff 100644
--- a/test/advection/Makefile.am
+++ b/test/advection/Makefile.am
@@ -1,11 +1,3 @@
 ## Process this file with automake to produce Makefile.in
 
 SUBDIRS = graphic order
-
-INCLUDES = -I$(top_srcdir)/src -I$(includedir) -DG_LOG_DOMAIN=\"Gfs-test\"\
-            $(GTS_CFLAGS)
-LDADD = $(GFS2D_LIBS)
-AM_CFLAGS = -DFTT_2D=1
-
-noinst_PROGRAMS = \
-	advection
diff --git a/test/advection/advection.c b/test/advection/advection.c
deleted file mode 100644
index 82264d6..0000000
--- a/test/advection/advection.c
+++ /dev/null
@@ -1,485 +0,0 @@
-/* Gerris - The GNU Flow Solver
- * Copyright (C) 2001 National Institute of Water and Atmospheric Research
- *
- * This program is free software; you can redistribute it and/or
- * modify it under the terms of the GNU General Public License as
- * published by the Free Software Foundation; either version 2 of the
- * License, or (at your option) any later version.
- *
- * This program is distributed in the hope that it will be useful,
- * but WITHOUT ANY WARRANTY; without even the implied warranty of
- * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.	See the GNU
- * General Public License for more details.
- *
- * You should have received a copy of the GNU General Public License
- * along with this program; if not, write to the Free Software
- * Foundation, Inc., 59 Temple Place - Suite 330, Boston, MA
- * 02111-1307, USA.  
- */
-
-#include <stdlib.h>
-#include <math.h>
-#include "config.h"
-#ifdef HAVE_GETOPT_H
-#  include <getopt.h>
-#endif /* HAVE_GETOPT_H */
-#ifdef HAVE_UNISTD_H
-#  include <unistd.h>
-#endif /* HAVE_UNISTD_H */
-
-#include "fluid.h" 
-#include "graphic.h"
-#include "solid.h"
-#include "advection.h"
-#include "init.h"
-
-#ifndef PI
-# define PI 3.14159265359
-#endif
-
-static gboolean refine (FttCell * cell, guint * maxlevel)
-{
-  if (ftt_cell_level (cell) < *maxlevel)
-    return TRUE;
-  return FALSE;
-}
-
-static gboolean refine_left (FttCell * cell, guint * maxlevel)
-{
-  if (ftt_cell_level (cell) < *maxlevel) {
-    FttVector pos;
-
-    ftt_cell_pos (cell, &pos);
-    if (pos.x < 0.)
-      return TRUE;
-  }
-  return FALSE;
-}
-
-static gboolean refine_right (FttCell * cell, guint * maxlevel)
-{
-  if (ftt_cell_level (cell) < *maxlevel) {
-    FttVector pos;
-
-    ftt_cell_pos (cell, &pos);
-    if (pos.x > 0.)
-      return TRUE;
-  }
-  return FALSE;
-}
-
-static gboolean refine_box (FttCell * cell, guint * maxlevel)
-{
-  if (ftt_cell_level (cell) < *maxlevel) {
-    FttVector pos;
-
-    ftt_cell_pos (cell, &pos);
-    if (pos.x < 0.25 && pos.x > -0.25 &&
-	pos.y < 0.25 && pos.y > -0.25)
-      return TRUE;
-  }
-  return FALSE;
-}
-
-static void smooth_gaussian (FttCell * cell)
-{
-  FttVector pos;
-  gdouble r2, coeff;
-
-  ftt_cell_pos (cell, &pos);
-  r2 = pos.x*pos.x + pos.y*pos.y;
-  coeff = 20. + 20000.*r2*r2*r2*r2;
-  GFS_STATE (cell)->p = 
-    (1. + cos(20.*pos.x)*cos(20.*pos.y))*exp (-coeff*r2)/2.;
-}
-
-static void smooth_periodic (FttCell * cell)
-{
-  FttVector pos;
-
-  ftt_cell_pos (cell, &pos);
-  GFS_STATE (cell)->p = (1. + cos(2.*PI*pos.x)*sin(2.*PI*pos.y))/2.;
-}
-
-static void rotate (FttCell * cell, gdouble * speed)
-{
-  FttVector pos;
-
-  ftt_cell_pos (cell, &pos);
-
-  GFS_STATE (cell)->u = - 2.*(*speed)*pos.y;
-  GFS_STATE (cell)->v = 2.*(*speed)*pos.x;
-}
-
-static void translate (FttCell * cell, gdouble * speed)
-{
-  gdouble theta = atan (1./2.);
-
-  GFS_STATE (cell)->u = cos (theta)*(*speed);
-  GFS_STATE (cell)->v = sin (theta)*(*speed);
-}
-
-static void update_fraction (FttCell * cell)
-{
-  GFS_STATE (cell)->p += GFS_STATE (cell)->div;
-}
-
-static void compute_error (FttCell * cell, 
-			   FttCell * ref)
-{
-  FttVector pos;
-  FttCell * locate;
-  
-  ftt_cell_pos (cell, &pos);
-  locate = ftt_cell_locate (ref, pos, -1);
-  g_assert (locate && ftt_cell_level (locate) == ftt_cell_level (cell));
-  GFS_STATE (cell)->res = GFS_STATE (cell)->p - GFS_STATE (locate)->p;
-}
-
-static void total_mass (FttCell * cell,
-			gdouble * mass)
-{
-  gdouble size = ftt_cell_size (cell);
-
-  *mass += GFS_STATE (cell)->p*size*size;
-}
-
-int main (int argc, char * argv[])
-{
-  FttCell * ref = NULL;
-  GfsBox * box;
-  GfsDomain * domain;
-  gdouble cfl = 0.5;
-  guint maxlevel = 6, t;
-  guint rightrefine = 0;
-  guint leftrefine = 0;
-  guint boxrefine = 0;
-  GtsRange stats;
-  gdouble total_mass_before = 0., total_mass_after = 0.;
-  guint tmax, twrite;
-  GfsAdvectionParams advection_params = { 
-    0.8, 1., NULL, NULL,
-    gfs_center_van_leer_gradient,
-    FALSE, TRUE,
-    gfs_face_advection_flux
-  };
-
-  int c = 0;
-  gboolean verbose = FALSE;
-  gboolean display_error = FALSE;
-  gboolean periodic = FALSE;
-  gboolean gtsfiles = TRUE;
-  void (* transform) (FttCell *, gdouble *) = rotate;
-  void (* smooth) (FttCell *) = NULL;
-
-  GtsBBox bbox;
-
-  bbox.x1 = bbox.y1 = -0.5;
-  bbox.x2 = bbox.y2 = 0.5;
-  bbox.z1 = bbox.z2 = 0.;
-
-  gfs_init (&argc, &argv);
-  advection_params.v = gfs_p;
-  advection_params.fv = gfs_div;
-
-  /* parse options using getopt */
-  while (c != EOF) {
-#ifdef HAVE_GETOPT_LONG
-    static struct option long_options[] = {
-      {"nogts", no_argument, NULL, 'N'},
-      {"nolimiter", no_argument, NULL, 'n'},
-      {"smooth", no_argument, NULL, 's'},
-      {"smooth1", no_argument, NULL, 'S'},
-      {"translate", no_argument, NULL, 't'},
-      {"periodic", no_argument, NULL, 'p'},
-      {"error", no_argument, NULL, 'e'},
-      {"right", required_argument, NULL, 'R'},
-      {"left", required_argument, NULL, 'r'},
-      {"box", required_argument, NULL, 'b'},
-      {"levels", required_argument, NULL, 'l'},
-      {"cfl", required_argument, NULL, 'c'},
-      {"help", no_argument, NULL, 'h'},
-      {"verbose", no_argument, NULL, 'v'},
-      {"version", no_argument, NULL, 'V'}
-    };
-    int option_index = 0;
-    switch ((c = getopt_long (argc, argv, "hvVc:l:r:eR:b:ptsSnN",
-			      long_options, &option_index))) {
-#else /* not HAVE_GETOPT_LONG */
-    switch ((c = getopt (argc, argv, "hvVc:l:r:eR:b:ptsSnN"))) {
-#endif /* not HAVE_GETOPT_LONG */
-    case 'N': /* nogts */
-      gtsfiles = FALSE;
-      break;
-    case 'n': /* nolimiter */
-      advection_params.gradient = gfs_center_gradient;
-      break;
-    case 's': /* smooth */
-      smooth = smooth_gaussian;
-      break;
-    case 'S': /* smooth1 */
-      smooth = smooth_periodic;
-      break;
-    case 't': /* translate */
-      transform = translate;
-      break;
-    case 'p': /* periodic */
-      periodic = TRUE;
-      break;
-    case 'e': /* error */
-      display_error = TRUE;
-      break;
-    case 'R': /* right */
-      rightrefine = atoi (optarg);
-      break;
-    case 'r': /* left */
-      leftrefine = atoi (optarg);
-      break;
-    case 'b': /* box */
-      boxrefine = atoi (optarg);
-      break;
-    case 'l': /* levels */
-      maxlevel = atoi (optarg);
-      break;
-    case 'c': /* cfl */
-      cfl = atof (optarg);
-      break;
-    case 'v': /* verbose */
-      verbose = TRUE;
-      break;
-    case 'h': /* help */
-      fprintf (stderr,
-     "Usage: advection [OPTION] < FILE\n"
-     "Advects a shape defined by volume fraction. FILE is a GTS file describing the interface.\n"
-     "\n"
-     "  -n    --nolimiter   do not use any limiter\n"
-     "  -N    --nogts       do not output GTS files\n"
-     "  -s    --smooth      advects smooth (gaussian) fraction field (do not use FILE)\n"
-     "  -S    --smooth1     advects smooth (periodic) fraction field (do not use FILE)\n"
-     "  -t    --translate   translation (default is rotation)\n"
-     "  -p    --periodic    set periodic boundaries in both directions\n"
-     "  -e    --error       display error relative to initial state\n"
-     "  -R L  --right=L     refine the right half of the mesh using L extra levels\n"
-     "  -r L  --left=L      refine the left half of the mesh using L extra levels\n"
-     "  -b L  --box=L       refine a central box using L extra levels\n"
-     "  -l L  --levels=L    maximum number of levels (default is 6)\n"
-     "  -c V  --cfl=V       change CFL (default is 0.5)\n"
-     "  -v    --verbose     display info, timing etc...\n"
-     "  -h    --help        display this help and exit\n"
-     "  -V    --version     output version information and exit\n"
-     "\n"
-     "Reports bugs to %s\n",
-	       FTT_MAINTAINER);
-      return 0; /* success */
-      break;
-    case 'V': /* version */
-      fprintf (stderr, 
-	       "advection: using %dD libgfs version %s\n"
-	       "compiled with flags: %s\n",
-	       FTT_DIMENSION,
-	       GFS_VERSION,
-	       GFS_COMPILATION_FLAGS);
-      return 0; /* succes */
-      break;
-    case '?': /* wrong options */
-      fprintf (stderr, "Try `advection --help' for more information.\n");
-      return 1; /* failure */
-    }
-  }
-
-  /* create cell tree with maxlevel */
-  domain = GFS_DOMAIN (gts_graph_new (GTS_GRAPH_CLASS (gfs_domain_class ()), 
-				     GTS_GNODE_CLASS (gfs_box_class ()),
-				     gts_gedge_class ()));
-  box = gfs_box_new (gfs_box_class ());
-  box->root = ftt_cell_new ((FttCellInitFunc) gfs_cell_init, domain);
-  gts_container_add (GTS_CONTAINER (domain), GTS_CONTAINEE (box));
-  ftt_cell_refine (box->root, (FttCellRefineFunc) refine, &maxlevel, 
-		   (FttCellInitFunc) gfs_cell_init, domain);
-
-  if (leftrefine > 0) {
-    maxlevel += leftrefine;
-    ftt_cell_refine (box->root, (FttCellRefineFunc) refine_left, &maxlevel, 
-		     (FttCellInitFunc) gfs_cell_init, domain);
-  }
-  else if (rightrefine > 0) {
-    maxlevel += rightrefine;
-    ftt_cell_refine (box->root, (FttCellRefineFunc) refine_right, &maxlevel, 
-		     (FttCellInitFunc) gfs_cell_init, domain);
-  }
-  else if (boxrefine > 0) {
-    maxlevel += boxrefine;
-    ftt_cell_refine (box->root, (FttCellRefineFunc) refine_box, &maxlevel, 
-		     (FttCellInitFunc) gfs_cell_init, domain);
-  }
-  
-  /* set periodic boundary conditions */
-  if (periodic) {
-    ftt_cell_set_neighbor (box->root, box->root, FTT_RIGHT, 
-			   (FttCellInitFunc) gfs_cell_init, domain);
-    ftt_cell_set_neighbor (box->root, box->root, FTT_LEFT, 
-			   (FttCellInitFunc) gfs_cell_init, domain);
-    ftt_cell_set_neighbor (box->root, box->root, FTT_TOP, 
-			   (FttCellInitFunc) gfs_cell_init, domain);
-    ftt_cell_set_neighbor (box->root, box->root, FTT_BOTTOM, 
-			   (FttCellInitFunc) gfs_cell_init, domain);
-  }
-
-  /* refine corners (eventually) */
-  ftt_cell_refine (box->root, 
-		   (FttCellRefineFunc) ftt_refine_corner, NULL,
-		   (FttCellInitFunc) gfs_cell_init, domain);
-
-  if (!smooth) {
-    GtsSurface * interface;
-    GtsFile * fp = gts_file_new (stdin);
-
-    /* read GTS surface */
-    interface = gts_surface_new (gts_surface_class (),
-				 gts_face_class (),
-				 gts_edge_class (),
-				 gts_vertex_class ());
-    if (gts_surface_read (interface, fp)) {
-      fprintf (stderr, 
-	       "advection: invalid GTS file\n"
-	       "%d:%d: %s\n",
-	       fp->line, fp->pos, fp->error);
-      return 1;
-    }
-    
-    /* compute solid fractions using surface */
-    gfs_domain_init_fraction (domain, interface, gfs_p);
-  }
-  else
-    ftt_cell_traverse (box->root, FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-		       (FttCellTraverseFunc) smooth, NULL);
-
-  /* initialize advection velocities */
-  {
-    gdouble size = ftt_level_size (maxlevel);
-    gdouble speed = cfl*size;
-
-    if (transform == rotate) {
-      twrite = PI/8./speed + 1;
-      speed = PI/8./twrite;
-    }
-    else {
-      twrite = 4.472135955/8./speed + 1;
-      speed = 4.472135955/8./twrite;
-    }
-    tmax = 8*twrite;
-    ftt_cell_traverse (box->root, FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-		       (FttCellTraverseFunc) transform, &speed);
-    /* compute MAC velocities from centered velocities */
-    ftt_face_traverse (box->root,  FTT_XYZ, 
-		       FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-		       (FttFaceTraverseFunc) gfs_face_reset_normal_velocity, 
-		       NULL);
-    ftt_face_traverse (box->root, FTT_XYZ,
-		       FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
- (FttFaceTraverseFunc) gfs_face_interpolated_normal_velocity, NULL);
-  }
-
-  if (display_error)
-    ref = ftt_cell_copy (box->root, (FttCellCopyFunc) gfs_cell_copy, domain);
-
-  ftt_cell_traverse (box->root, FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-		     (FttCellTraverseFunc) total_mass, &total_mass_before);
-  if (verbose)
-    fprintf (stderr, "total mass: %g\n", total_mass_before);
-
-  for (t = 0; t < tmax; t++) {
-    if (t % twrite == 0) {
-      if (verbose) {
-	stats = gfs_stats_variable (box->root, gfs_p, FTT_TRAVERSE_LEAFS, -1);
-	fprintf (stderr, 
-		 "fraction min: %g avg: %g| %g max: %g n: %7d\n",
-		 stats.min, stats.mean, stats.stddev, stats.max, stats.n);
-      }
-
-      if (gtsfiles) {
-	char fname[80];
-	FILE * fp;
-
-	sprintf (fname, "advected.%05d.gts", t);
-	fp = fopen (fname, "wt");
-	gfs_write_gts (domain, gfs_p, FTT_TRAVERSE_LEAFS, -1, &bbox, fp);
-	fclose (fp);
-	if (verbose)
-	  fprintf (stderr, "advected.%05d.gts written\n", t);
-      }
-
-      if (display_error) {
-	GfsNorm norm;
-	static guint n = 0;
-
-	ftt_cell_traverse (box->root, FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-			   (FttCellTraverseFunc) compute_error, ref);
-	norm = gfs_norm_variable (box->root, gfs_res, FTT_TRAVERSE_LEAFS, -1);
-	fprintf (stderr, 
-	   "Error n: %d first: %g second: %g infty: %g bias: %g w: %g\n",
-		 n++, norm.first, norm.second, norm.infty, norm.bias, norm.w);
-	if (gtsfiles) {
-	  char fname[80];
-	  FILE * fp;
-	  
-	  sprintf (fname, "error.%05d.gts", t);
-	  fp = fopen (fname, "wt");
-	  gfs_write_gts (domain, gfs_res, FTT_TRAVERSE_LEAFS, -1, &bbox, fp);
-	  fclose (fp);
-	  fprintf (stderr, "error.%05d.gts written\n", t);
-	}
-      }
-    }
-    ftt_cell_traverse (box->root, FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-		       (FttCellTraverseFunc) gfs_cell_reset, 
-		       advection_params.fv);
-    ftt_cell_traverse (box->root, FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-		       (FttCellTraverseFunc) gfs_cell_advected_face_values,
-		       &advection_params);
-    ftt_face_traverse (box->root, FTT_XYZ,
-		       FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-		       (FttFaceTraverseFunc) gfs_face_advection_flux,
-		       &advection_params);
-    ftt_cell_traverse (box->root, FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-		       (FttCellTraverseFunc) update_fraction, NULL);
-  }
-
-  if (gtsfiles) {
-    char fname[80];
-    FILE * fp;
-    
-    sprintf (fname, "advected.%05d.gts", t);
-    fp = fopen (fname, "wt");
-    gfs_write_gts (domain, gfs_p, FTT_TRAVERSE_LEAFS, -1, &bbox, fp);
-    fclose (fp);
-    if (verbose)
-      fprintf (stderr, "advected.%05d.gts written\n", t);
-  }
-
-  if (display_error) {
-    GfsNorm norm;
-    
-    ftt_cell_traverse (box->root, FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-		       (FttCellTraverseFunc) compute_error, ref);
-    norm = gfs_norm_variable (box->root, gfs_res, FTT_TRAVERSE_LEAFS, -1);
-    fprintf (stderr, 
-	     "Error n: 8 first: %g second: %g infty: %g bias: %g n: %g\n",
-	     norm.first, norm.second, norm.infty, norm.bias, norm.w);
-  }
-  
-  stats = gfs_stats_variable (box->root, gfs_p, FTT_TRAVERSE_LEAFS, -1);
-  ftt_cell_traverse (box->root, FTT_PRE_ORDER, FTT_TRAVERSE_LEAFS, -1,
-		     (FttCellTraverseFunc) total_mass, &total_mass_after);
-  if (verbose)
-    fprintf (stderr, 
-	     "fraction min: %g avg: %g| %g max: %g n: %7d\n"
-	     "total mass: %g\n",
-	     stats.min, stats.mean, stats.stddev, stats.max, stats.n,
-	     total_mass_after);
-
-  if (fabs (total_mass_before - total_mass_after) > 1e-10 ||
-      stats.min < -1e-2 || stats.max > 1. + 1e-2)
-    return 1; /* failure */
-  return 0; /* success */
-}
diff --git a/test/advection/graphic/Makefile.am b/test/advection/graphic/Makefile.am
index 358c175..9d05627 100644
--- a/test/advection/graphic/Makefile.am
+++ b/test/advection/graphic/Makefile.am
@@ -4,21 +4,21 @@ TESTS = test.sh
 
 EXTRA_DIST = \
 	check.sh \
-	cleanup.sh \
+	conservation.sh \
 	report.sh \
 	tests
 
 test.sh: star.gts
 	@echo "#! /bin/sh" > test.sh
 	@echo "rm -f report.ps" >> test.sh
-	@echo "./check.sh \"tests/*\";" >> test.sh
+	@echo "sh check.sh \"tests/*\";" >> test.sh
 	@chmod +x test.sh
 
 report.ps: report.sh timestamp
-	./report.sh "tests/*"
+	sh report.sh "tests/*"
 
 star.gts:
 	../../poisson/shapes star | transform -i -s 0.9 > star.gts
 
 clean-generic:
-	./cleanup.sh
+	$(RM) -f tests/*/*.eps tests/*/log tests/*/*~ tests/*/core timestamp test.sh star.gts
diff --git a/test/advection/graphic/check.sh b/test/advection/graphic/check.sh
index e597c64..d64bc62 100755
--- a/test/advection/graphic/check.sh
+++ b/test/advection/graphic/check.sh
@@ -11,7 +11,7 @@ PATH=$PATH:../../../../poisson:../../..
 for test in $1; do
     cd $test
     if gerris2D advection.gfs | gfsview-batch2D graphics.gfs 2> /dev/null; then
-	if ../../conservation.sh; then
+	if sh ../../conservation.sh; then
 	    echo "PASS: `basename $test`"
 	else
 	    failed=`expr $failed + 1`;
diff --git a/test/advection/graphic/cleanup.sh b/test/advection/graphic/cleanup.sh
deleted file mode 100755
index e860366..0000000
--- a/test/advection/graphic/cleanup.sh
+++ /dev/null
@@ -1,6 +0,0 @@
-#! /bin/sh
-
-for file in tests/*; do
-    rm -f $file/*.eps $file/log $file/*~ $file/core
-done
-rm -f timestamp
diff --git a/test/advection/order/Makefile.am b/test/advection/order/Makefile.am
index 9c17ddd..9d1b078 100644
--- a/test/advection/order/Makefile.am
+++ b/test/advection/order/Makefile.am
@@ -6,19 +6,17 @@ EXTRA_DIST = \
 	order.sh \
 	check.sh \
 	order.par \
-	reference \
-	avgorder.awk \
-	checkorder.awk \
-	report.sh
+	report.sh \
+	tests
 
-test.sh:
+test.sh: Makefile.am
 	@echo "#! /bin/sh" > test.sh
 	@echo "rm -f report.ps" >> test.sh
-	@echo "./check.sh \"reference/*.xmgr\" 0.9" >> test.sh
+	@echo "sh check.sh \"tests/*\" 1.9" >> test.sh
 	@chmod +x test.sh
 
 report.ps: report.sh timestamp
-	./report.sh "reference/*.xmgr"
+	sh report.sh "tests/*"
 
 clean-generic:
-	$(RM) -r -f figures test
+	$(RM) -f tests/*/result.* tests/*/*~ tests/*/core timestamp test.sh
diff --git a/test/advection/order/avgorder.awk b/test/advection/order/avgorder.awk
deleted file mode 100644
index 0eae530..0000000
--- a/test/advection/order/avgorder.awk
+++ /dev/null
@@ -1,44 +0,0 @@
-BEGIN {
-  ingraph = 0;
-  indata = 0;
-  sum = 0.;
-  n = 0;
-}
-{
-  if ($1 == "@WITH") {
-    if ($2 == "G0")
-      ingraph = 0;
-    else if ($2 == "G1")
-      ingraph = 1;
-    else if ($2 == "G2")
-      ingraph = 0;
-    else if ($2 == "G3")
-      ingraph = 1;
-  }
-  else if (ingraph) {
-    if ($1 == "@TYPE") {
-      if (n > 0) {
-	avgorder = sum/n;
-	printf ("%g ", avgorder);
-      }
-      indata = 1;
-      sum = 0.;
-      n = 0;
-    }
-    else if ($1 == "&")
-      indata = 0;
-    else if (indata) {
-      sum += $2;
-      n++;
-    }
-  }
-}
-END {
-  if (n > 0) {
-    avgorder = sum/n;
-    printf ("%g\n", avgorder);
-  }
-  else
-    exit 1;
-  exit 0;
-}
diff --git a/test/advection/order/check.sh b/test/advection/order/check.sh
index ed56d95..327f926 100755
--- a/test/advection/order/check.sh
+++ b/test/advection/order/check.sh
@@ -1,46 +1,24 @@
 #! /bin/sh
 
 if test -z "$1"; then
-    echo "usage: check.sh REFERENCES TOLERANCE"
-    echo "  REFERENCES: reference xmgr files. example: \"reference/*.xmgr\""
-    echo "  TOLERANCE:  1 no tolerance: 0: maximum tolerance"
+    echo "usage: check.sh DIRECTORIES ORDER"
     exit 1
 fi
 
-if test -e test; then
-    :
-else
-    mkdir test;
-fi
-
 failed=0; all=0;
 startdate=`date +%s`
 for file in $1; do
-    testfile=test/`basename $file`
-    sname=`basename $file | awk '{print substr ($1, 1, index ($1, ".") - 1)}'`
-    command=`awk '\
-	BEGIN{ FS=" |\""; }\
-	{\
-	    if ($1 == "@description") {\
-		for (i = 3; i <= NF; i++)\
-		    printf ("%s ", $i);\
-		exit 0;\
-	    }\
-	}\' < $file`
-    maxlevel=`awk 'BEGIN{max=0} /^[[:space:]]+[[:digit:]|^.|-]+[[:space:]]+[[:digit:]|^.|-]+/ {if ($1 > max) max = $1;} END {print max}' < $file`
-    ./order.sh "$command" $maxlevel > $testfile
-    avg=`awk -f avgorder.awk < $testfile`
-    avgref="$avg `awk -f avgorder.awk < $file`"
-    if echo $avgref | awk -v tol=$2 -f checkorder.awk; then
+    sname=`basename $file`
+    if sh order.sh 3 8 $file/advection.gfs $2 > $file/result.xmgr; then
 	all=`expr $all + 1`;
-	echo "PASS: $sname [$avg]"
+	echo "PASS: $sname"
     else
 	all=`expr $all + 1`;
 	failed=`expr $failed + 1`;
-	echo "FAIL: $sname [$avg]"
+	echo "FAIL: $sname"
     fi
-    expr `date +%s` - $startdate > timestamp
 done
+expr `date +%s` - $startdate > timestamp
 
 if test "$failed" -eq 0; then
     banner="All $all tests passed";
diff --git a/test/advection/order/checkorder.awk b/test/advection/order/checkorder.awk
deleted file mode 100644
index 6f453c7..0000000
--- a/test/advection/order/checkorder.awk
+++ /dev/null
@@ -1,9 +0,0 @@
-{
-  n = NF/2;
-  if (n != 6)
-    exit 1;
-  for (i = 1; i <= n; i++)
-    if ($i < $(i + n)*tol)
-      exit 1;
-  exit 0;
-}
diff --git a/test/advection/order/order.par b/test/advection/order/order.par
index 7974901..cd6913c 100644
--- a/test/advection/order/order.par
+++ b/test/advection/order/order.par
@@ -883,863 +883,3 @@ g1 fixedpoint prec 6, 6
     frame color 1
     frame fill off
     frame background color 0
-with g2
-g2 on
-g2 label off
-g2 hidden false
-g2 type logy
-g2 autoscale type AUTO
-g2 fixedpoint off
-g2 fixedpoint type 0
-g2 fixedpoint xy 0.000000, 0.000000
-g2 fixedpoint format general general
-g2 fixedpoint prec 6, 6
-    world xmin 3
-    world xmax 8
-    world ymin 0.0001
-    world ymax 1
-    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-    view xmin 0.575000
-    view xmax 0.950000
-    view ymin 0.100000
-    view ymax 0.475000
-    title ""
-    title font 4
-    title size 1.500000
-    title color 1
-    title linewidth 1
-    subtitle ""
-    subtitle font 4
-    subtitle size 1.000000
-    subtitle color 1
-    subtitle linewidth 1
-    s0 symbol 2
-    s0 symbol size 0.340000
-    s0 symbol fill 1
-    s0 symbol color 1
-    s0 symbol linewidth 1
-    s0 symbol linestyle 1
-    s0 symbol center false
-    s0 symbol char 0
-    s0 skip 0
-    s0 linestyle 1
-    s0 linewidth 1
-    s0 color 1
-    s0 fill 0
-    s0 fill with color
-    s0 fill color 1
-    s0 fill pattern 0
-    s0 errorbar type BOTH
-    s0 errorbar length 1.000000
-    s0 errorbar linewidth 1
-    s0 errorbar linestyle 1
-    s0 errorbar riser on
-    s0 errorbar riser linewidth 1
-    s0 errorbar riser linestyle 1
-    s0 xyz 0.000000, 0.000000
-    s0 comment "/tmp/toto"
-    s1 symbol 3
-    s1 symbol size 0.440000
-    s1 symbol fill 2
-    s1 symbol color 1
-    s1 symbol linewidth 1
-    s1 symbol linestyle 1
-    s1 symbol center false
-    s1 symbol char 0
-    s1 skip 0
-    s1 linestyle 1
-    s1 linewidth 1
-    s1 color 1
-    s1 fill 0
-    s1 fill with color
-    s1 fill color 1
-    s1 fill pattern 0
-    s1 errorbar type BOTH
-    s1 errorbar length 1.000000
-    s1 errorbar linewidth 1
-    s1 errorbar linestyle 1
-    s1 errorbar riser on
-    s1 errorbar riser linewidth 1
-    s1 errorbar riser linestyle 1
-    s1 xyz 0.000000, 0.000000
-    s1 comment "/tmp/toto"
-    s2 symbol 5
-    s2 symbol size 0.340000
-    s2 symbol fill 1
-    s2 symbol color 1
-    s2 symbol linewidth 1
-    s2 symbol linestyle 1
-    s2 symbol center false
-    s2 symbol char 0
-    s2 skip 0
-    s2 linestyle 1
-    s2 linewidth 1
-    s2 color 1
-    s2 fill 0
-    s2 fill with color
-    s2 fill color 1
-    s2 fill pattern 0
-    s2 errorbar type BOTH
-    s2 errorbar length 1.000000
-    s2 errorbar linewidth 1
-    s2 errorbar linestyle 1
-    s2 errorbar riser on
-    s2 errorbar riser linewidth 1
-    s2 errorbar riser linestyle 1
-    s2 xyz 0.000000, 0.000000
-    s2 comment "/tmp/toto"
-    s3 symbol 2
-    s3 symbol size 0.340000
-    s3 symbol fill 1
-    s3 symbol color 4
-    s3 symbol linewidth 1
-    s3 symbol linestyle 1
-    s3 symbol center false
-    s3 symbol char 0
-    s3 skip 0
-    s3 linestyle 1
-    s3 linewidth 1
-    s3 color 4
-    s3 fill 0
-    s3 fill with color
-    s3 fill color 1
-    s3 fill pattern 0
-    s3 errorbar type BOTH
-    s3 errorbar length 1.000000
-    s3 errorbar linewidth 1
-    s3 errorbar linestyle 1
-    s3 errorbar riser on
-    s3 errorbar riser linewidth 1
-    s3 errorbar riser linestyle 1
-    s3 xyz 0.000000, 0.000000
-    s3 comment "test/rotate_smooth.xmgr"
-    s4 symbol 3
-    s4 symbol size 0.440000
-    s4 symbol fill 2
-    s4 symbol color 4
-    s4 symbol linewidth 1
-    s4 symbol linestyle 1
-    s4 symbol center false
-    s4 symbol char 0
-    s4 skip 0
-    s4 linestyle 1
-    s4 linewidth 1
-    s4 color 4
-    s4 fill 0
-    s4 fill with color
-    s4 fill color 1
-    s4 fill pattern 0
-    s4 errorbar type BOTH
-    s4 errorbar length 1.000000
-    s4 errorbar linewidth 1
-    s4 errorbar linestyle 1
-    s4 errorbar riser on
-    s4 errorbar riser linewidth 1
-    s4 errorbar riser linestyle 1
-    s4 xyz 0.000000, 0.000000
-    s4 comment "test/rotate_smooth.xmgr"
-    s5 symbol 5
-    s5 symbol size 0.340000
-    s5 symbol fill 1
-    s5 symbol color 4
-    s5 symbol linewidth 1
-    s5 symbol linestyle 1
-    s5 symbol center false
-    s5 symbol char 0
-    s5 skip 0
-    s5 linestyle 1
-    s5 linewidth 1
-    s5 color 4
-    s5 fill 0
-    s5 fill with color
-    s5 fill color 1
-    s5 fill pattern 0
-    s5 errorbar type BOTH
-    s5 errorbar length 1.000000
-    s5 errorbar linewidth 1
-    s5 errorbar linestyle 1
-    s5 errorbar riser on
-    s5 errorbar riser linewidth 1
-    s5 errorbar riser linestyle 1
-    s5 xyz 0.000000, 0.000000
-    s5 comment "test/rotate_smooth.xmgr"
-    xaxis  tick on
-    xaxis  tick major 1
-    xaxis  tick minor 0.5
-    xaxis  tick offsetx 0.000000
-    xaxis  tick offsety 0.000000
-    xaxis  label "Level"
-    xaxis  label layout para
-    xaxis  label place auto
-    xaxis  label char size 0.600000
-    xaxis  label font 4
-    xaxis  label color 1
-    xaxis  label linewidth 1
-    xaxis  ticklabel on
-    xaxis  ticklabel type auto
-    xaxis  ticklabel prec 5
-    xaxis  ticklabel format general
-    xaxis  ticklabel append ""
-    xaxis  ticklabel prepend ""
-    xaxis  ticklabel layout horizontal
-    xaxis  ticklabel place on ticks
-    xaxis  ticklabel skip 0
-    xaxis  ticklabel stagger 0
-    xaxis  ticklabel op bottom
-    xaxis  ticklabel sign normal
-    xaxis  ticklabel start type auto
-    xaxis  ticklabel start 0.000000
-    xaxis  ticklabel stop type auto
-    xaxis  ticklabel stop 0.000000
-    xaxis  ticklabel char size 0.600000
-    xaxis  ticklabel font 4
-    xaxis  ticklabel color 1
-    xaxis  ticklabel linewidth 1
-    xaxis  tick major on
-    xaxis  tick minor on
-    xaxis  tick default 6
-    xaxis  tick in
-    xaxis  tick major color 1
-    xaxis  tick major linewidth 1
-    xaxis  tick major linestyle 1
-    xaxis  tick minor color 1
-    xaxis  tick minor linewidth 1
-    xaxis  tick minor linestyle 1
-    xaxis  tick log off
-    xaxis  tick size 1.000000
-    xaxis  tick minor size 0.500000
-    xaxis  bar off
-    xaxis  bar color 1
-    xaxis  bar linestyle 1
-    xaxis  bar linewidth 1
-    xaxis  tick major grid off
-    xaxis  tick minor grid off
-    xaxis  tick op both
-    xaxis  tick type auto
-    xaxis  tick spec 0
-    yaxis  tick on
-    yaxis  tick major 1
-    yaxis  tick minor 1
-    yaxis  tick offsetx 0.000000
-    yaxis  tick offsety 0.000000
-    yaxis  label "Error (2*Pi)"
-    yaxis  label layout para
-    yaxis  label place auto
-    yaxis  label char size 0.600000
-    yaxis  label font 4
-    yaxis  label color 1
-    yaxis  label linewidth 1
-    yaxis  ticklabel on
-    yaxis  ticklabel type auto
-    yaxis  ticklabel prec 0
-    yaxis  ticklabel format general
-    yaxis  ticklabel append ""
-    yaxis  ticklabel prepend ""
-    yaxis  ticklabel layout horizontal
-    yaxis  ticklabel place on ticks
-    yaxis  ticklabel skip 0
-    yaxis  ticklabel stagger 0
-    yaxis  ticklabel op left
-    yaxis  ticklabel sign normal
-    yaxis  ticklabel start type auto
-    yaxis  ticklabel start 0.000000
-    yaxis  ticklabel stop type auto
-    yaxis  ticklabel stop 0.000000
-    yaxis  ticklabel char size 0.600000
-    yaxis  ticklabel font 4
-    yaxis  ticklabel color 1
-    yaxis  ticklabel linewidth 1
-    yaxis  tick major on
-    yaxis  tick minor on
-    yaxis  tick default 6
-    yaxis  tick in
-    yaxis  tick major color 1
-    yaxis  tick major linewidth 1
-    yaxis  tick major linestyle 3
-    yaxis  tick minor color 1
-    yaxis  tick minor linewidth 1
-    yaxis  tick minor linestyle 1
-    yaxis  tick log off
-    yaxis  tick size 1.000000
-    yaxis  tick minor size 0.500000
-    yaxis  bar off
-    yaxis  bar color 1
-    yaxis  bar linestyle 1
-    yaxis  bar linewidth 1
-    yaxis  tick major grid on
-    yaxis  tick minor grid off
-    yaxis  tick op both
-    yaxis  tick type auto
-    yaxis  tick spec 0
-    zeroxaxis  tick on
-    zeroxaxis  tick major 1
-    zeroxaxis  tick minor 0.5
-    zeroxaxis  tick offsetx 0.000000
-    zeroxaxis  tick offsety 0.000000
-    zeroxaxis  label ""
-    zeroxaxis  label layout para
-    zeroxaxis  label place auto
-    zeroxaxis  label char size 1.000000
-    zeroxaxis  label font 4
-    zeroxaxis  label color 1
-    zeroxaxis  label linewidth 1
-    zeroxaxis  ticklabel off
-    zeroxaxis  ticklabel type auto
-    zeroxaxis  ticklabel prec 5
-    zeroxaxis  ticklabel format general
-    zeroxaxis  ticklabel append ""
-    zeroxaxis  ticklabel prepend ""
-    zeroxaxis  ticklabel layout horizontal
-    zeroxaxis  ticklabel place on ticks
-    zeroxaxis  ticklabel skip 0
-    zeroxaxis  ticklabel stagger 0
-    zeroxaxis  ticklabel op bottom
-    zeroxaxis  ticklabel sign normal
-    zeroxaxis  ticklabel start type auto
-    zeroxaxis  ticklabel start 0.000000
-    zeroxaxis  ticklabel stop type auto
-    zeroxaxis  ticklabel stop 0.000000
-    zeroxaxis  ticklabel char size 1.000000
-    zeroxaxis  ticklabel font 4
-    zeroxaxis  ticklabel color 1
-    zeroxaxis  ticklabel linewidth 1
-    zeroxaxis  tick major off
-    zeroxaxis  tick minor on
-    zeroxaxis  tick default 6
-    zeroxaxis  tick in
-    zeroxaxis  tick major color 1
-    zeroxaxis  tick major linewidth 1
-    zeroxaxis  tick major linestyle 1
-    zeroxaxis  tick minor color 1
-    zeroxaxis  tick minor linewidth 1
-    zeroxaxis  tick minor linestyle 1
-    zeroxaxis  tick log off
-    zeroxaxis  tick size 1.000000
-    zeroxaxis  tick minor size 0.500000
-    zeroxaxis  bar off
-    zeroxaxis  bar color 1
-    zeroxaxis  bar linestyle 1
-    zeroxaxis  bar linewidth 1
-    zeroxaxis  tick major grid off
-    zeroxaxis  tick minor grid off
-    zeroxaxis  tick op both
-    zeroxaxis  tick type auto
-    zeroxaxis  tick spec 0
-    zeroyaxis  tick on
-    zeroyaxis  tick major 1
-    zeroyaxis  tick minor 1
-    zeroyaxis  tick offsetx 0.000000
-    zeroyaxis  tick offsety 0.000000
-    zeroyaxis  label ""
-    zeroyaxis  label layout para
-    zeroyaxis  label place auto
-    zeroyaxis  label char size 1.000000
-    zeroyaxis  label font 4
-    zeroyaxis  label color 1
-    zeroyaxis  label linewidth 1
-    zeroyaxis  ticklabel off
-    zeroyaxis  ticklabel type auto
-    zeroyaxis  ticklabel prec 0
-    zeroyaxis  ticklabel format decimal
-    zeroyaxis  ticklabel append ""
-    zeroyaxis  ticklabel prepend ""
-    zeroyaxis  ticklabel layout horizontal
-    zeroyaxis  ticklabel place on ticks
-    zeroyaxis  ticklabel skip 0
-    zeroyaxis  ticklabel stagger 0
-    zeroyaxis  ticklabel op left
-    zeroyaxis  ticklabel sign normal
-    zeroyaxis  ticklabel start type auto
-    zeroyaxis  ticklabel start 0.000000
-    zeroyaxis  ticklabel stop type auto
-    zeroyaxis  ticklabel stop 0.000000
-    zeroyaxis  ticklabel char size 1.000000
-    zeroyaxis  ticklabel font 4
-    zeroyaxis  ticklabel color 1
-    zeroyaxis  ticklabel linewidth 1
-    zeroyaxis  tick major off
-    zeroyaxis  tick minor on
-    zeroyaxis  tick default 6
-    zeroyaxis  tick in
-    zeroyaxis  tick major color 1
-    zeroyaxis  tick major linewidth 1
-    zeroyaxis  tick major linestyle 1
-    zeroyaxis  tick minor color 1
-    zeroyaxis  tick minor linewidth 1
-    zeroyaxis  tick minor linestyle 1
-    zeroyaxis  tick log off
-    zeroyaxis  tick size 1.000000
-    zeroyaxis  tick minor size 0.500000
-    zeroyaxis  bar off
-    zeroyaxis  bar color 1
-    zeroyaxis  bar linestyle 1
-    zeroyaxis  bar linewidth 1
-    zeroyaxis  tick major grid off
-    zeroyaxis  tick minor grid off
-    zeroyaxis  tick op both
-    zeroyaxis  tick type auto
-    zeroyaxis  tick spec 0
-    legend on
-    legend loctype view
-    legend layout 0
-    legend vgap 2
-    legend hgap 1
-    legend length 4
-    legend box off
-    legend box fill off
-    legend box fill with color
-    legend box fill color 0
-    legend box fill pattern 1
-    legend box color 1
-    legend box linewidth 1
-    legend box linestyle 1
-    legend x1 0.61
-    legend y1 0.25
-    legend font 4
-    legend char size 0.460000
-    legend linestyle 1
-    legend linewidth 1
-    legend color 1
-    legend string 0 "first"
-    legend string 1 "second"
-    legend string 2 "infinite"
-    legend string 3 "first (new)"
-    legend string 4 "second (new)"
-    legend string 5 "infinite (new)"
-    frame on
-    frame type 0
-    frame linestyle 1
-    frame linewidth 1
-    frame color 1
-    frame fill off
-    frame background color 0
-with g3
-g3 on
-g3 label off
-g3 hidden false
-g3 type xy
-g3 autoscale type AUTO
-g3 fixedpoint off
-g3 fixedpoint type 0
-g3 fixedpoint xy 0.000000, 0.000000
-g3 fixedpoint format general general
-g3 fixedpoint prec 6, 6
-    world xmin 4
-    world xmax 8
-    world ymin 0.5
-    world ymax 2.5
-    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-    view xmin 0.575000
-    view xmax 0.950000
-    view ymin 0.575000
-    view ymax 0.950000
-    title ""
-    title font 4
-    title size 1.500000
-    title color 1
-    title linewidth 1
-    subtitle ""
-    subtitle font 4
-    subtitle size 1.000000
-    subtitle color 1
-    subtitle linewidth 1
-    s0 symbol 2
-    s0 symbol size 0.340000
-    s0 symbol fill 1
-    s0 symbol color 1
-    s0 symbol linewidth 1
-    s0 symbol linestyle 1
-    s0 symbol center false
-    s0 symbol char 0
-    s0 skip 0
-    s0 linestyle 1
-    s0 linewidth 1
-    s0 color 1
-    s0 fill 0
-    s0 fill with color
-    s0 fill color 1
-    s0 fill pattern 0
-    s0 errorbar type BOTH
-    s0 errorbar length 1.000000
-    s0 errorbar linewidth 1
-    s0 errorbar linestyle 1
-    s0 errorbar riser on
-    s0 errorbar riser linewidth 1
-    s0 errorbar riser linestyle 1
-    s0 xyz 0.000000, 0.000000
-    s0 comment "/tmp/toto"
-    s1 symbol 3
-    s1 symbol size 0.440000
-    s1 symbol fill 2
-    s1 symbol color 1
-    s1 symbol linewidth 1
-    s1 symbol linestyle 1
-    s1 symbol center false
-    s1 symbol char 0
-    s1 skip 0
-    s1 linestyle 1
-    s1 linewidth 1
-    s1 color 1
-    s1 fill 0
-    s1 fill with color
-    s1 fill color 1
-    s1 fill pattern 0
-    s1 errorbar type BOTH
-    s1 errorbar length 1.000000
-    s1 errorbar linewidth 1
-    s1 errorbar linestyle 1
-    s1 errorbar riser on
-    s1 errorbar riser linewidth 1
-    s1 errorbar riser linestyle 1
-    s1 xyz 0.000000, 0.000000
-    s1 comment "/tmp/toto"
-    s2 symbol 5
-    s2 symbol size 0.340000
-    s2 symbol fill 1
-    s2 symbol color 1
-    s2 symbol linewidth 1
-    s2 symbol linestyle 1
-    s2 symbol center false
-    s2 symbol char 0
-    s2 skip 0
-    s2 linestyle 1
-    s2 linewidth 1
-    s2 color 1
-    s2 fill 0
-    s2 fill with color
-    s2 fill color 1
-    s2 fill pattern 0
-    s2 errorbar type BOTH
-    s2 errorbar length 1.000000
-    s2 errorbar linewidth 1
-    s2 errorbar linestyle 1
-    s2 errorbar riser on
-    s2 errorbar riser linewidth 1
-    s2 errorbar riser linestyle 1
-    s2 xyz 0.000000, 0.000000
-    s2 comment "/tmp/toto"
-    s3 symbol 2
-    s3 symbol size 0.340000
-    s3 symbol fill 1
-    s3 symbol color 4
-    s3 symbol linewidth 1
-    s3 symbol linestyle 1
-    s3 symbol center false
-    s3 symbol char 0
-    s3 skip 0
-    s3 linestyle 1
-    s3 linewidth 1
-    s3 color 4
-    s3 fill 0
-    s3 fill with color
-    s3 fill color 1
-    s3 fill pattern 0
-    s3 errorbar type BOTH
-    s3 errorbar length 1.000000
-    s3 errorbar linewidth 1
-    s3 errorbar linestyle 1
-    s3 errorbar riser on
-    s3 errorbar riser linewidth 1
-    s3 errorbar riser linestyle 1
-    s3 xyz 0.000000, 0.000000
-    s3 comment "test/rotate_smooth.xmgr"
-    s4 symbol 3
-    s4 symbol size 0.440000
-    s4 symbol fill 2
-    s4 symbol color 4
-    s4 symbol linewidth 1
-    s4 symbol linestyle 1
-    s4 symbol center false
-    s4 symbol char 0
-    s4 skip 0
-    s4 linestyle 1
-    s4 linewidth 1
-    s4 color 4
-    s4 fill 0
-    s4 fill with color
-    s4 fill color 1
-    s4 fill pattern 0
-    s4 errorbar type BOTH
-    s4 errorbar length 1.000000
-    s4 errorbar linewidth 1
-    s4 errorbar linestyle 1
-    s4 errorbar riser on
-    s4 errorbar riser linewidth 1
-    s4 errorbar riser linestyle 1
-    s4 xyz 0.000000, 0.000000
-    s4 comment "test/rotate_smooth.xmgr"
-    s5 symbol 5
-    s5 symbol size 0.340000
-    s5 symbol fill 1
-    s5 symbol color 4
-    s5 symbol linewidth 1
-    s5 symbol linestyle 1
-    s5 symbol center false
-    s5 symbol char 0
-    s5 skip 0
-    s5 linestyle 1
-    s5 linewidth 1
-    s5 color 4
-    s5 fill 0
-    s5 fill with color
-    s5 fill color 1
-    s5 fill pattern 0
-    s5 errorbar type BOTH
-    s5 errorbar length 1.000000
-    s5 errorbar linewidth 1
-    s5 errorbar linestyle 1
-    s5 errorbar riser on
-    s5 errorbar riser linewidth 1
-    s5 errorbar riser linestyle 1
-    s5 xyz 0.000000, 0.000000
-    s5 comment "test/rotate_smooth.xmgr"
-    xaxis  tick on
-    xaxis  tick major 1
-    xaxis  tick minor 0.5
-    xaxis  tick offsetx 0.000000
-    xaxis  tick offsety 0.000000
-    xaxis  label "Level"
-    xaxis  label layout para
-    xaxis  label place auto
-    xaxis  label char size 0.600000
-    xaxis  label font 4
-    xaxis  label color 1
-    xaxis  label linewidth 1
-    xaxis  ticklabel on
-    xaxis  ticklabel type auto
-    xaxis  ticklabel prec 5
-    xaxis  ticklabel format general
-    xaxis  ticklabel append ""
-    xaxis  ticklabel prepend ""
-    xaxis  ticklabel layout horizontal
-    xaxis  ticklabel place on ticks
-    xaxis  ticklabel skip 0
-    xaxis  ticklabel stagger 0
-    xaxis  ticklabel op bottom
-    xaxis  ticklabel sign normal
-    xaxis  ticklabel start type auto
-    xaxis  ticklabel start 0.000000
-    xaxis  ticklabel stop type auto
-    xaxis  ticklabel stop 0.000000
-    xaxis  ticklabel char size 0.600000
-    xaxis  ticklabel font 4
-    xaxis  ticklabel color 1
-    xaxis  ticklabel linewidth 1
-    xaxis  tick major on
-    xaxis  tick minor on
-    xaxis  tick default 6
-    xaxis  tick in
-    xaxis  tick major color 1
-    xaxis  tick major linewidth 1
-    xaxis  tick major linestyle 1
-    xaxis  tick minor color 1
-    xaxis  tick minor linewidth 1
-    xaxis  tick minor linestyle 1
-    xaxis  tick log off
-    xaxis  tick size 1.000000
-    xaxis  tick minor size 0.500000
-    xaxis  bar off
-    xaxis  bar color 1
-    xaxis  bar linestyle 1
-    xaxis  bar linewidth 1
-    xaxis  tick major grid off
-    xaxis  tick minor grid off
-    xaxis  tick op both
-    xaxis  tick type auto
-    xaxis  tick spec 0
-    yaxis  tick on
-    yaxis  tick major 0.5
-    yaxis  tick minor 0.25
-    yaxis  tick offsetx 0.000000
-    yaxis  tick offsety 0.000000
-    yaxis  label "Order (2*Pi)"
-    yaxis  label layout para
-    yaxis  label place auto
-    yaxis  label char size 0.600000
-    yaxis  label font 4
-    yaxis  label color 1
-    yaxis  label linewidth 1
-    yaxis  ticklabel on
-    yaxis  ticklabel type auto
-    yaxis  ticklabel prec 5
-    yaxis  ticklabel format general
-    yaxis  ticklabel append ""
-    yaxis  ticklabel prepend ""
-    yaxis  ticklabel layout horizontal
-    yaxis  ticklabel place on ticks
-    yaxis  ticklabel skip 0
-    yaxis  ticklabel stagger 0
-    yaxis  ticklabel op left
-    yaxis  ticklabel sign normal
-    yaxis  ticklabel start type auto
-    yaxis  ticklabel start 0.000000
-    yaxis  ticklabel stop type auto
-    yaxis  ticklabel stop 0.000000
-    yaxis  ticklabel char size 0.600000
-    yaxis  ticklabel font 4
-    yaxis  ticklabel color 1
-    yaxis  ticklabel linewidth 1
-    yaxis  tick major on
-    yaxis  tick minor on
-    yaxis  tick default 6
-    yaxis  tick in
-    yaxis  tick major color 1
-    yaxis  tick major linewidth 1
-    yaxis  tick major linestyle 1
-    yaxis  tick minor color 1
-    yaxis  tick minor linewidth 1
-    yaxis  tick minor linestyle 1
-    yaxis  tick log off
-    yaxis  tick size 1.000000
-    yaxis  tick minor size 0.500000
-    yaxis  bar off
-    yaxis  bar color 1
-    yaxis  bar linestyle 1
-    yaxis  bar linewidth 1
-    yaxis  tick major grid off
-    yaxis  tick minor grid off
-    yaxis  tick op both
-    yaxis  tick type auto
-    yaxis  tick spec 0
-    zeroxaxis  tick on
-    zeroxaxis  tick major 1
-    zeroxaxis  tick minor 0.5
-    zeroxaxis  tick offsetx 0.000000
-    zeroxaxis  tick offsety 0.000000
-    zeroxaxis  label ""
-    zeroxaxis  label layout para
-    zeroxaxis  label place auto
-    zeroxaxis  label char size 1.000000
-    zeroxaxis  label font 4
-    zeroxaxis  label color 1
-    zeroxaxis  label linewidth 1
-    zeroxaxis  ticklabel off
-    zeroxaxis  ticklabel type auto
-    zeroxaxis  ticklabel prec 5
-    zeroxaxis  ticklabel format general
-    zeroxaxis  ticklabel append ""
-    zeroxaxis  ticklabel prepend ""
-    zeroxaxis  ticklabel layout horizontal
-    zeroxaxis  ticklabel place on ticks
-    zeroxaxis  ticklabel skip 0
-    zeroxaxis  ticklabel stagger 0
-    zeroxaxis  ticklabel op bottom
-    zeroxaxis  ticklabel sign normal
-    zeroxaxis  ticklabel start type auto
-    zeroxaxis  ticklabel start 0.000000
-    zeroxaxis  ticklabel stop type auto
-    zeroxaxis  ticklabel stop 0.000000
-    zeroxaxis  ticklabel char size 0.610000
-    zeroxaxis  ticklabel font 4
-    zeroxaxis  ticklabel color 1
-    zeroxaxis  ticklabel linewidth 1
-    zeroxaxis  tick major off
-    zeroxaxis  tick minor on
-    zeroxaxis  tick default 6
-    zeroxaxis  tick in
-    zeroxaxis  tick major color 1
-    zeroxaxis  tick major linewidth 1
-    zeroxaxis  tick major linestyle 1
-    zeroxaxis  tick minor color 1
-    zeroxaxis  tick minor linewidth 1
-    zeroxaxis  tick minor linestyle 1
-    zeroxaxis  tick log off
-    zeroxaxis  tick size 1.000000
-    zeroxaxis  tick minor size 0.500000
-    zeroxaxis  bar off
-    zeroxaxis  bar color 1
-    zeroxaxis  bar linestyle 1
-    zeroxaxis  bar linewidth 1
-    zeroxaxis  tick major grid off
-    zeroxaxis  tick minor grid off
-    zeroxaxis  tick op both
-    zeroxaxis  tick type auto
-    zeroxaxis  tick spec 0
-    zeroyaxis  tick on
-    zeroyaxis  tick major 0.5
-    zeroyaxis  tick minor 0.25
-    zeroyaxis  tick offsetx 0.000000
-    zeroyaxis  tick offsety 0.000000
-    zeroyaxis  label ""
-    zeroyaxis  label layout para
-    zeroyaxis  label place auto
-    zeroyaxis  label char size 1.000000
-    zeroyaxis  label font 4
-    zeroyaxis  label color 1
-    zeroyaxis  label linewidth 1
-    zeroyaxis  ticklabel off
-    zeroyaxis  ticklabel type auto
-    zeroyaxis  ticklabel prec 5
-    zeroyaxis  ticklabel format general
-    zeroyaxis  ticklabel append ""
-    zeroyaxis  ticklabel prepend ""
-    zeroyaxis  ticklabel layout horizontal
-    zeroyaxis  ticklabel place on ticks
-    zeroyaxis  ticklabel skip 0
-    zeroyaxis  ticklabel stagger 0
-    zeroyaxis  ticklabel op left
-    zeroyaxis  ticklabel sign normal
-    zeroyaxis  ticklabel start type auto
-    zeroyaxis  ticklabel start 0.000000
-    zeroyaxis  ticklabel stop type auto
-    zeroyaxis  ticklabel stop 0.000000
-    zeroyaxis  ticklabel char size 0.610000
-    zeroyaxis  ticklabel font 4
-    zeroyaxis  ticklabel color 1
-    zeroyaxis  ticklabel linewidth 1
-    zeroyaxis  tick major off
-    zeroyaxis  tick minor on
-    zeroyaxis  tick default 6
-    zeroyaxis  tick in
-    zeroyaxis  tick major color 1
-    zeroyaxis  tick major linewidth 1
-    zeroyaxis  tick major linestyle 1
-    zeroyaxis  tick minor color 1
-    zeroyaxis  tick minor linewidth 1
-    zeroyaxis  tick minor linestyle 1
-    zeroyaxis  tick log off
-    zeroyaxis  tick size 1.000000
-    zeroyaxis  tick minor size 0.500000
-    zeroyaxis  bar off
-    zeroyaxis  bar color 1
-    zeroyaxis  bar linestyle 1
-    zeroyaxis  bar linewidth 1
-    zeroyaxis  tick major grid off
-    zeroyaxis  tick minor grid off
-    zeroyaxis  tick op both
-    zeroyaxis  tick type auto
-    zeroyaxis  tick spec 0
-    legend on
-    legend loctype view
-    legend layout 0
-    legend vgap 2
-    legend hgap 1
-    legend length 4
-    legend box off
-    legend box fill off
-    legend box fill with color
-    legend box fill color 0
-    legend box fill pattern 1
-    legend box color 1
-    legend box linewidth 1
-    legend box linestyle 1
-    legend x1 0.61
-    legend y1 0.91
-    legend font 4
-    legend char size 0.450000
-    legend linestyle 1
-    legend linewidth 1
-    legend color 1
-    legend string 0 "first"
-    legend string 1 "second"
-    legend string 2 "infinite"
-    legend string 3 "first (new)"
-    legend string 4 "second (new)"
-    legend string 5 "infinite (new)"
-    frame on
-    frame type 0
-    frame linestyle 1
-    frame linewidth 1
-    frame color 1
-    frame fill off
-    frame background color 0
diff --git a/test/advection/order/order.sh b/test/advection/order/order.sh
index 3713fb9..7c8237a 100755
--- a/test/advection/order/order.sh
+++ b/test/advection/order/order.sh
@@ -1,137 +1,66 @@
-#! /bin/sh
+#!/bin/sh
 
-if test -z "$1"; then
-    echo "usage: order.sh COMMAND [MAXLEVEL]"
-    echo "  MAXLEVEL: maximum level to test (default is 7)"
-    exit 1
-fi
+usage()
+{
+	cat <<EOF
+Usage: order LMIN LMAX FILE ORDER
 
-if test -z "$2"; then
-    maxlevel=7
-else
-    maxlevel=$2
-fi
+Generates an xmgr file for the order of convergence of simulation FILE.
 
-PATH=$PATH:..
-command=$1
-rm -f /tmp/error
-for level in `seq 3 1 $maxlevel`; do
-    res=`/bin/sh -c "$command -N -e -l $level 2>&1" | awk '{if ($1 == "Error" && $3 != 0 && $3 % 4 == 0) print $3 " " $5 " " $7 " " $9;}'`
-    echo $level $res >> /tmp/error
-done
-
-awk 'BEGIN {n = 0} {
-    level[n] = $1;
-    e11[n] = $3; e21[n] = $4; ei1[n] = $5;
-    e12[n] = $7; e22[n] = $8; ei2[n++] = $9;
+EOF
+	exit $1
 }
-END {
-    for (i = 1; i < n; i++)
-	print level[i] " " sqrt (e11[i-1]/e11[i]) " " sqrt (e21[i-1]/e21[i]) " " sqrt (ei1[i-1]/ei1[i]) " " sqrt (e12[i-1]/e12[i]) " " sqrt (e22[i-1]/e22[i]) " " sqrt (ei2[i-1]/ei2[i]);
-}' < /tmp/error > /tmp/order
-
-echo "@description \"$command\""
 
-echo "@WITH G0" 
-echo "@G0 ON" 
-echo "@G0 TYPE logy" 
-echo "@XAXIS LABEL \"Level\"" 
-echo "@xaxis label char size 0.6" 
-echo "@xaxis ticklabel char size 0.6" 
-echo "@YAXIS LABEL \"Error (Pi)\""
-echo "@yaxis label char size 0.6" 
-echo "@yaxis ticklabel char size 0.6" 
-echo "@LEGEND STRING 0 \"first\""
-echo "@LEGEND STRING 1 \"second\""
-echo "@LEGEND STRING 2 \"infinite\""
-echo "@TARGET S0" 
-echo "@TYPE xy" 
-awk '{print $1 " " $3}' < /tmp/error
-echo "&" 
-echo "@TARGET S1" 
-echo "@TYPE xy" 
-awk '{print $1 " " $4}' < /tmp/error
-echo "&" 
-echo "@TARGET S2" 
-echo "@TYPE xy" 
-awk '{print $1 " " $5}' < /tmp/error
-echo "&" 
-
-echo "@WITH G2"
-echo "@G2 ON" 
-echo "@G2 TYPE logy" 
-echo "@XAXIS LABEL \"Level\"" 
-echo "@xaxis label char size 0.6" 
-echo "@xaxis ticklabel char size 0.6" 
-echo "@YAXIS LABEL \"Error (2*Pi)\""
-echo "@yaxis label char size 0.6" 
-echo "@yaxis ticklabel char size 0.6" 
-echo "@LEGEND STRING 0 \"first\""
-echo "@LEGEND STRING 1 \"second\""
-echo "@LEGEND STRING 2 \"infinite\""
-echo "@TARGET S0" 
-echo "@TYPE xy" 
-awk '{print $1 " " $7}' < /tmp/error
-echo "&" 
-echo "@TARGET S1" 
-echo "@TYPE xy" 
-awk '{print $1 " " $8}' < /tmp/error
-echo "&" 
-echo "@TARGET S2" 
-echo "@TYPE xy" 
-awk '{print $1 " " $9}' < /tmp/error
-echo "&" 
+if test $# -lt 4; then
+	usage 1 1>&2
+fi
 
-rm -f /tmp/error
+if for level in `seq $1 1 $2`; do
+  sed "s/LEVEL/$level/g" < $3 | gerris2D -
+done | awk -v order=$4 '
+BEGIN { n = 0 }
+{
+  l[n] = $1
+  l1[n] = $2
+  l2[n] = $3
+  li[n++] = $4
+}
+END {
+  print "@target G0.S3"
+  print "@type xy"
+  for (i = 0; i < n; i++)
+    print l[i] " " l1[i];
+  print "@target G0.S4"
+  print "@type xy"
+  for (i = 0; i < n; i++)
+    print l[i] " " l2[i];
+  print "@target G0.S5"
+  print "@type xy"
+  for (i = 0; i < n; i++)
+    print l[i] " " li[i];
 
-echo "@WITH G1" 
-echo "@G1 ON" 
-echo "@G1 TYPE xy" 
-echo "@XAXIS LABEL \"Level\"" 
-echo "@xaxis label char size 0.6" 
-echo "@xaxis ticklabel char size 0.6" 
-echo "@YAXIS LABEL \"Order (Pi)\""
-echo "@yaxis label char size 0.6" 
-echo "@yaxis ticklabel char size 0.6" 
-echo "@LEGEND STRING 0 \"first\""
-echo "@LEGEND STRING 1 \"second\""
-echo "@LEGEND STRING 2 \"infinite\""
-echo "@TARGET S0" 
-echo "@TYPE xy" 
-awk '{print $1 " " $2}' < /tmp/order
-echo "&" 
-echo "@TARGET S1" 
-echo "@TYPE xy" 
-awk '{print $1 " " $3}' < /tmp/order
-echo "&" 
-echo "@TARGET S2" 
-echo "@TYPE xy" 
-awk '{print $1 " " $4}' < /tmp/order
-echo "&" 
+ print "@target G1.S3"
+  print "@type xy"
+  for (i = 1; i < n; i++)
+    print l[i] " " log(l1[i-1]/l1[i])/log(2);
+  print "@target G1.S4"
+  print "@type xy"
+  for (i = 1; i < n; i++)
+    print l[i] " " log(l2[i-1]/l2[i])/log(2);
+  print "@target G1.S5"
+  print "@type xy"
+  for (i = 1; i < n; i++)
+    print l[i] " " log(li[i-1]/li[i])/log(2);
 
-echo "@WITH G3"
-echo "@G3 ON" 
-echo "@G3 TYPE xy" 
-echo "@XAXIS LABEL \"Level\"" 
-echo "@xaxis label char size 0.6" 
-echo "@xaxis ticklabel char size 0.6" 
-echo "@YAXIS LABEL \"Order (2*Pi)\""
-echo "@yaxis label char size 0.6" 
-echo "@yaxis ticklabel char size 0.6" 
-echo "@LEGEND STRING 0 \"first\""
-echo "@LEGEND STRING 1 \"second\""
-echo "@LEGEND STRING 2 \"infinite\""
-echo "@TARGET S0" 
-echo "@TYPE xy" 
-awk '{print $1 " " $5}' < /tmp/order
-echo "&" 
-echo "@TARGET S1" 
-echo "@TYPE xy" 
-awk '{print $1 " " $6}' < /tmp/order
-echo "&" 
-echo "@TARGET S2" 
-echo "@TYPE xy" 
-awk '{print $1 " " $7}' < /tmp/order
-echo "&" 
+  if (log(l1[n-2]/l1[n-1])/log(2) < order || 
+      log(l2[n-2]/l2[n-1])/log(2) < order || 
+      log(li[n-2]/li[n-1])/log(2) < order)
+    exit (1);
+  else
+    exit (0);  
+}'; then
+    exit 0
+else
+    exit 1
+fi
 
-rm -f /tmp/order
diff --git a/test/advection/order/reference/rotate_smooth.xmgr b/test/advection/order/reference/rotate_smooth.xmgr
deleted file mode 100644
index f2e603b..0000000
--- a/test/advection/order/reference/rotate_smooth.xmgr
+++ /dev/null
@@ -1,1544 +0,0 @@
-# ACE/gr parameter file
-#
- at version 40102
- at page layout free
- at ps linewidth begin 1
- at ps linewidth increment 2
- at hardcopy device 1
- at description "advection -n -s"
- at page 5
- at page inout 5
- at link page off
- at default linestyle 1
- at default linewidth 1
- at default color 1
- at default char size 1.000000
- at default font 4
- at default font source 0
- at default symbol size 1.000000
- at timestamp off
- at timestamp 0.03, 0.03
- at timestamp linewidth 1
- at timestamp color 1
- at timestamp rot 0
- at timestamp font 4
- at timestamp char size 1.000000
- at timestamp def "Thu Oct 25 21:28:04 2001"
- at with g0
- at g0 on
- at g0 label off
- at g0 hidden false
- at g0 type logy
- at g0 autoscale type AUTO
- at g0 fixedpoint off
- at g0 fixedpoint type 0
- at g0 fixedpoint xy 0.000000, 0.000000
- at g0 fixedpoint format general general
- at g0 fixedpoint prec 6, 6
-@    world xmin 3
-@    world xmax 8
-@    world ymin 0.0001
-@    world ymax 1
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.100000
-@    view xmax 0.475000
-@    view ymin 0.100000
-@    view ymax 0.475000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 1
-@    yaxis  tick minor 1
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Error (Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 0
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.590000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 3
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid on
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 1.000000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 1
-@    zeroyaxis  tick minor 1
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 0
-@    zeroyaxis  ticklabel format decimal
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 1.000000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.14
-@    legend y1 0.25
-@    legend font 4
-@    legend char size 0.460000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at with g1
- at g1 on
- at g1 label off
- at g1 hidden false
- at g1 type xy
- at g1 autoscale type AUTO
- at g1 fixedpoint off
- at g1 fixedpoint type 0
- at g1 fixedpoint xy 0.000000, 0.000000
- at g1 fixedpoint format general general
- at g1 fixedpoint prec 6, 6
-@    world xmin 4
-@    world xmax 8
-@    world ymin 0.5
-@    world ymax 2.5
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.100000
-@    view xmax 0.475000
-@    view ymin 0.575000
-@    view ymax 0.950000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 0.5
-@    yaxis  tick minor 0.25
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Order (Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 5
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.600000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 3
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid off
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 0.590000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 0.5
-@    zeroyaxis  tick minor 0.25
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 5
-@    zeroyaxis  ticklabel format general
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 0.590000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.14
-@    legend y1 0.91
-@    legend font 4
-@    legend char size 0.460000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at with g2
- at g2 on
- at g2 label off
- at g2 hidden false
- at g2 type logy
- at g2 autoscale type AUTO
- at g2 fixedpoint off
- at g2 fixedpoint type 0
- at g2 fixedpoint xy 0.000000, 0.000000
- at g2 fixedpoint format general general
- at g2 fixedpoint prec 6, 6
-@    world xmin 3
-@    world xmax 8
-@    world ymin 0.0001
-@    world ymax 1
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.575000
-@    view xmax 0.950000
-@    view ymin 0.100000
-@    view ymax 0.475000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 1
-@    yaxis  tick minor 1
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Error (2*Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 0
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.590000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 3
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid on
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 1.000000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 1
-@    zeroyaxis  tick minor 1
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 0
-@    zeroyaxis  ticklabel format decimal
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 1.000000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.61
-@    legend y1 0.25
-@    legend font 4
-@    legend char size 0.460000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at with g3
- at g3 on
- at g3 label off
- at g3 hidden false
- at g3 type xy
- at g3 autoscale type AUTO
- at g3 fixedpoint off
- at g3 fixedpoint type 0
- at g3 fixedpoint xy 0.000000, 0.000000
- at g3 fixedpoint format general general
- at g3 fixedpoint prec 6, 6
-@    world xmin 4
-@    world xmax 8
-@    world ymin 0.5
-@    world ymax 2.5
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.575000
-@    view xmax 0.950000
-@    view ymin 0.575000
-@    view ymax 0.950000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 0.5
-@    yaxis  tick minor 0.25
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Order (2*Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 5
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.600000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 1
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid off
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 0.610000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 0.5
-@    zeroyaxis  tick minor 0.25
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 5
-@    zeroyaxis  ticklabel format general
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 0.610000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.61
-@    legend y1 0.91
-@    legend font 4
-@    legend char size 0.450000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at WITH G0
- at G0 ON
- at TARGET S0
- at TYPE xy
-               3        0.0290524
-               4        0.0314117
-               5        0.0148229
-               6       0.00408973
-               7      0.000944308
-               8      0.000223637
-&
- at TARGET S1
- at TYPE xy
-               3        0.0418173
-               4         0.058832
-               5        0.0288787
-               6       0.00788679
-               7       0.00185035
-               8      0.000447359
-&
- at TARGET S2
- at TYPE xy
-               3         0.118038
-               4         0.209858
-               5         0.135958
-               6        0.0355945
-               7        0.0083567
-               8       0.00200035
-&
- at WITH G1
- at G1 ON
- at TARGET S0
- at TYPE xy
-               4         0.961713
-               5          1.45572
-               6          1.90379
-               7          2.08109
-               8          2.05487
-&
- at TARGET S1
- at TYPE xy
-               4         0.843085
-               5          1.42731
-               6          1.91355
-               7          2.06454
-               8          2.03376
-&
- at TARGET S2
- at TYPE xy
-               4         0.749977
-               5           1.2424
-               6          1.95439
-               7          2.06383
-               8          2.04392
-&
- at WITH G2
- at G2 ON
- at TARGET S0
- at TYPE xy
-               3         0.034609
-               4        0.0351749
-               5        0.0215563
-               6        0.0075428
-               7       0.00186405
-               8      0.000446626
-&
- at TARGET S1
- at TYPE xy
-               3        0.0528661
-               4        0.0656732
-               5        0.0421456
-               6        0.0146422
-               7       0.00366082
-               8      0.000893506
-&
- at TARGET S2
- at TYPE xy
-               3          0.16984
-               4          0.28183
-               5         0.195652
-               6         0.067105
-               7        0.0165911
-               8       0.00399591
-&
- at WITH G3
- at G3 ON
- at TARGET S0
- at TYPE xy
-               4         0.991923
-               5          1.27741
-               6          1.69052
-               7          2.01158
-               8          2.04295
-&
- at TARGET S1
- at TYPE xy
-               4         0.897211
-               5           1.2483
-               6          1.69657
-               7          1.99993
-               8          2.02414
-&
- at TARGET S2
- at TYPE xy
-               4         0.776294
-               5          1.20019
-               6          1.70752
-               7          2.01113
-               8          2.03765
-&
diff --git a/test/advection/order/reference/translate_periodic.xmgr b/test/advection/order/reference/translate_periodic.xmgr
deleted file mode 100644
index 7660b9c..0000000
--- a/test/advection/order/reference/translate_periodic.xmgr
+++ /dev/null
@@ -1,1544 +0,0 @@
-# ACE/gr parameter file
-#
- at version 40102
- at page layout free
- at ps linewidth begin 1
- at ps linewidth increment 2
- at hardcopy device 1
- at description "advection -n -S -t -p"
- at page 5
- at page inout 5
- at link page off
- at default linestyle 1
- at default linewidth 1
- at default color 1
- at default char size 1.000000
- at default font 4
- at default font source 0
- at default symbol size 1.000000
- at timestamp off
- at timestamp 0.03, 0.03
- at timestamp linewidth 1
- at timestamp color 1
- at timestamp rot 0
- at timestamp font 4
- at timestamp char size 1.000000
- at timestamp def "Fri Oct 26 01:02:29 2001"
- at with g0
- at g0 on
- at g0 label off
- at g0 hidden false
- at g0 type logy
- at g0 autoscale type AUTO
- at g0 fixedpoint off
- at g0 fixedpoint type 0
- at g0 fixedpoint xy 0.000000, 0.000000
- at g0 fixedpoint format general general
- at g0 fixedpoint prec 6, 6
-@    world xmin 3
-@    world xmax 8
-@    world ymin 1e-05
-@    world ymax 1
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.100000
-@    view xmax 0.475000
-@    view ymin 0.100000
-@    view ymax 0.475000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 1
-@    yaxis  tick minor 1
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Error (Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 0
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.590000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 3
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid on
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 1.000000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 1
-@    zeroyaxis  tick minor 1
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 0
-@    zeroyaxis  ticklabel format decimal
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 1.000000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.14
-@    legend y1 0.25
-@    legend font 4
-@    legend char size 0.460000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at with g1
- at g1 on
- at g1 label off
- at g1 hidden false
- at g1 type xy
- at g1 autoscale type AUTO
- at g1 fixedpoint off
- at g1 fixedpoint type 0
- at g1 fixedpoint xy 0.000000, 0.000000
- at g1 fixedpoint format general general
- at g1 fixedpoint prec 6, 6
-@    world xmin 4
-@    world xmax 8
-@    world ymin 0
-@    world ymax 4
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.100000
-@    view xmax 0.475000
-@    view ymin 0.575000
-@    view ymax 0.950000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 1
-@    yaxis  tick minor 0.5
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Order (Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 5
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.600000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 3
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid off
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 0.590000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 0.2
-@    zeroyaxis  tick minor 0.1
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 5
-@    zeroyaxis  ticklabel format general
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 0.590000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.14
-@    legend y1 0.91
-@    legend font 4
-@    legend char size 0.460000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at with g2
- at g2 on
- at g2 label off
- at g2 hidden false
- at g2 type logy
- at g2 autoscale type AUTO
- at g2 fixedpoint off
- at g2 fixedpoint type 0
- at g2 fixedpoint xy 0.000000, 0.000000
- at g2 fixedpoint format general general
- at g2 fixedpoint prec 6, 6
-@    world xmin 3
-@    world xmax 8
-@    world ymin 1e-05
-@    world ymax 1
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.575000
-@    view xmax 0.950000
-@    view ymin 0.100000
-@    view ymax 0.475000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 1
-@    yaxis  tick minor 1
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Error (2*Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 0
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.590000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 3
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid on
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 1.000000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 1
-@    zeroyaxis  tick minor 1
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 0
-@    zeroyaxis  ticklabel format decimal
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 1.000000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.61
-@    legend y1 0.25
-@    legend font 4
-@    legend char size 0.460000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at with g3
- at g3 on
- at g3 label off
- at g3 hidden false
- at g3 type xy
- at g3 autoscale type AUTO
- at g3 fixedpoint off
- at g3 fixedpoint type 0
- at g3 fixedpoint xy 0.000000, 0.000000
- at g3 fixedpoint format general general
- at g3 fixedpoint prec 6, 6
-@    world xmin 4
-@    world xmax 8
-@    world ymin 0
-@    world ymax 4
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.575000
-@    view xmax 0.950000
-@    view ymin 0.575000
-@    view ymax 0.950000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 1
-@    yaxis  tick minor 0.5
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Order (2*Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 5
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.600000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 1
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid off
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 0.610000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 0.2
-@    zeroyaxis  tick minor 0.1
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 5
-@    zeroyaxis  ticklabel format general
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 0.610000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.61
-@    legend y1 0.91
-@    legend font 4
-@    legend char size 0.450000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at WITH G0
- at G0 ON
- at TARGET S0
- at TYPE xy
-               3         0.113852
-               4        0.0220837
-               5       0.00330886
-               6      0.000614581
-               7      0.000137828
-               8      3.33582e-05
-&
- at TARGET S1
- at TYPE xy
-               3         0.135684
-               4        0.0265382
-               5       0.00408814
-               6      0.000728704
-               7      0.000156594
-               8      3.72889e-05
-&
- at TARGET S2
- at TYPE xy
-               3         0.248043
-               4        0.0518354
-               5       0.00817044
-               6       0.00141182
-               7      0.000277677
-               8      6.04723e-05
-&
- at WITH G1
- at G1 ON
- at TARGET S0
- at TYPE xy
-               4          2.27057
-               5          2.58343
-               6          2.32033
-               7          2.11164
-               8          2.03267
-&
- at TARGET S1
- at TYPE xy
-               4          2.26115
-               5          2.54784
-               6          2.36858
-               7          2.15719
-               8          2.04926
-&
- at TARGET S2
- at TYPE xy
-               4          2.18751
-               5          2.51878
-               6          2.40565
-               7          2.25486
-               8          2.14285
-&
- at WITH G2
- at G2 ON
- at TARGET S0
- at TYPE xy
-               3         0.165194
-               4        0.0416457
-               5       0.00657382
-               6       0.00122834
-               7      0.000275635
-               8      6.67158e-05
-&
- at TARGET S1
- at TYPE xy
-               3         0.195432
-               4        0.0502415
-               5       0.00812265
-               6       0.00145638
-               7      0.000313163
-               8      7.45772e-05
-&
- at TARGET S2
- at TYPE xy
-               3            0.353
-               4        0.0985138
-               5        0.0162328
-               6       0.00282138
-               7      0.000555302
-               8      0.000120943
-&
- at WITH G3
- at G3 ON
- at TARGET S0
- at TYPE xy
-               4          1.99165
-               5          2.51696
-               6          2.31339
-               7          2.11102
-               8           2.0326
-&
- at TARGET S1
- at TYPE xy
-               4          1.97227
-               5          2.48704
-               6          2.36163
-               7          2.15651
-               8          2.04919
-&
- at TARGET S2
- at TYPE xy
-               4          1.89295
-               5           2.4635
-               6          2.39864
-               7          2.25406
-               8          2.14276
-&
diff --git a/test/advection/order/reference/translate_smooth.xmgr b/test/advection/order/reference/translate_smooth.xmgr
deleted file mode 100644
index f1bae07..0000000
--- a/test/advection/order/reference/translate_smooth.xmgr
+++ /dev/null
@@ -1,1544 +0,0 @@
-# ACE/gr parameter file
-#
- at version 40102
- at page layout free
- at ps linewidth begin 1
- at ps linewidth increment 2
- at hardcopy device 1
- at description "advection -n -s -t -p"
- at page 5
- at page inout 5
- at link page off
- at default linestyle 1
- at default linewidth 1
- at default color 1
- at default char size 1.000000
- at default font 4
- at default font source 0
- at default symbol size 1.000000
- at timestamp off
- at timestamp 0.03, 0.03
- at timestamp linewidth 1
- at timestamp color 1
- at timestamp rot 0
- at timestamp font 4
- at timestamp char size 1.000000
- at timestamp def "Thu Oct 25 23:55:46 2001"
- at with g0
- at g0 on
- at g0 label off
- at g0 hidden false
- at g0 type logy
- at g0 autoscale type AUTO
- at g0 fixedpoint off
- at g0 fixedpoint type 0
- at g0 fixedpoint xy 0.000000, 0.000000
- at g0 fixedpoint format general general
- at g0 fixedpoint prec 6, 6
-@    world xmin 3
-@    world xmax 8
-@    world ymin 0.0001
-@    world ymax 1
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.100000
-@    view xmax 0.475000
-@    view ymin 0.100000
-@    view ymax 0.475000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 1
-@    yaxis  tick minor 1
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Error (Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 0
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.600000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 3
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid on
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 1.000000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 1
-@    zeroyaxis  tick minor 1
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 0
-@    zeroyaxis  ticklabel format decimal
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 1.000000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.14
-@    legend y1 0.25
-@    legend font 4
-@    legend char size 0.460000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at with g1
- at g1 on
- at g1 label off
- at g1 hidden false
- at g1 type xy
- at g1 autoscale type AUTO
- at g1 fixedpoint off
- at g1 fixedpoint type 0
- at g1 fixedpoint xy 0.000000, 0.000000
- at g1 fixedpoint format general general
- at g1 fixedpoint prec 6, 6
-@    world xmin 4
-@    world xmax 8
-@    world ymin 0.5
-@    world ymax 2.5
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.100000
-@    view xmax 0.475000
-@    view ymin 0.575000
-@    view ymax 0.950000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 0.5
-@    yaxis  tick minor 0.25
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Order (Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 5
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.600000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 3
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid off
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 0.590000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 0.5
-@    zeroyaxis  tick minor 0.25
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 5
-@    zeroyaxis  ticklabel format general
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 0.590000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.14
-@    legend y1 0.91
-@    legend font 4
-@    legend char size 0.460000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at with g2
- at g2 on
- at g2 label off
- at g2 hidden false
- at g2 type logy
- at g2 autoscale type AUTO
- at g2 fixedpoint off
- at g2 fixedpoint type 0
- at g2 fixedpoint xy 0.000000, 0.000000
- at g2 fixedpoint format general general
- at g2 fixedpoint prec 6, 6
-@    world xmin 3
-@    world xmax 8
-@    world ymin 0.0001
-@    world ymax 1
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.575000
-@    view xmax 0.950000
-@    view ymin 0.100000
-@    view ymax 0.475000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 1
-@    yaxis  tick minor 1
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Error (2*Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 0
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.600000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 3
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid on
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 1.000000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 1
-@    zeroyaxis  tick minor 1
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 0
-@    zeroyaxis  ticklabel format decimal
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 1.000000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.61
-@    legend y1 0.25
-@    legend font 4
-@    legend char size 0.460000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at with g3
- at g3 on
- at g3 label off
- at g3 hidden false
- at g3 type xy
- at g3 autoscale type AUTO
- at g3 fixedpoint off
- at g3 fixedpoint type 0
- at g3 fixedpoint xy 0.000000, 0.000000
- at g3 fixedpoint format general general
- at g3 fixedpoint prec 6, 6
-@    world xmin 4
-@    world xmax 8
-@    world ymin 0.5
-@    world ymax 2.5
-@    stack world 0, 0, 0, 0 tick 0, 0, 0, 0
-@    view xmin 0.575000
-@    view xmax 0.950000
-@    view ymin 0.575000
-@    view ymax 0.950000
-@    title ""
-@    title font 4
-@    title size 1.500000
-@    title color 1
-@    title linewidth 1
-@    subtitle ""
-@    subtitle font 4
-@    subtitle size 1.000000
-@    subtitle color 1
-@    subtitle linewidth 1
-@    s0 symbol 2
-@    s0 symbol size 0.340000
-@    s0 symbol fill 1
-@    s0 symbol color 1
-@    s0 symbol linewidth 1
-@    s0 symbol linestyle 1
-@    s0 symbol center false
-@    s0 symbol char 0
-@    s0 skip 0
-@    s0 linestyle 1
-@    s0 linewidth 1
-@    s0 color 1
-@    s0 fill 0
-@    s0 fill with color
-@    s0 fill color 1
-@    s0 fill pattern 0
-@    s0 errorbar type BOTH
-@    s0 errorbar length 1.000000
-@    s0 errorbar linewidth 1
-@    s0 errorbar linestyle 1
-@    s0 errorbar riser on
-@    s0 errorbar riser linewidth 1
-@    s0 errorbar riser linestyle 1
-@    s0 xyz 0.000000, 0.000000
-@    s0 comment "/tmp/toto"
-@    s1 symbol 3
-@    s1 symbol size 0.440000
-@    s1 symbol fill 2
-@    s1 symbol color 1
-@    s1 symbol linewidth 1
-@    s1 symbol linestyle 1
-@    s1 symbol center false
-@    s1 symbol char 0
-@    s1 skip 0
-@    s1 linestyle 1
-@    s1 linewidth 1
-@    s1 color 1
-@    s1 fill 0
-@    s1 fill with color
-@    s1 fill color 1
-@    s1 fill pattern 0
-@    s1 errorbar type BOTH
-@    s1 errorbar length 1.000000
-@    s1 errorbar linewidth 1
-@    s1 errorbar linestyle 1
-@    s1 errorbar riser on
-@    s1 errorbar riser linewidth 1
-@    s1 errorbar riser linestyle 1
-@    s1 xyz 0.000000, 0.000000
-@    s1 comment "/tmp/toto"
-@    s2 symbol 5
-@    s2 symbol size 0.340000
-@    s2 symbol fill 1
-@    s2 symbol color 1
-@    s2 symbol linewidth 1
-@    s2 symbol linestyle 1
-@    s2 symbol center false
-@    s2 symbol char 0
-@    s2 skip 0
-@    s2 linestyle 1
-@    s2 linewidth 1
-@    s2 color 1
-@    s2 fill 0
-@    s2 fill with color
-@    s2 fill color 1
-@    s2 fill pattern 0
-@    s2 errorbar type BOTH
-@    s2 errorbar length 1.000000
-@    s2 errorbar linewidth 1
-@    s2 errorbar linestyle 1
-@    s2 errorbar riser on
-@    s2 errorbar riser linewidth 1
-@    s2 errorbar riser linestyle 1
-@    s2 xyz 0.000000, 0.000000
-@    s2 comment "/tmp/toto"
-@    xaxis  tick on
-@    xaxis  tick major 1
-@    xaxis  tick minor 0.5
-@    xaxis  tick offsetx 0.000000
-@    xaxis  tick offsety 0.000000
-@    xaxis  label "Level"
-@    xaxis  label layout para
-@    xaxis  label place auto
-@    xaxis  label char size 0.600000
-@    xaxis  label font 4
-@    xaxis  label color 1
-@    xaxis  label linewidth 1
-@    xaxis  ticklabel on
-@    xaxis  ticklabel type auto
-@    xaxis  ticklabel prec 5
-@    xaxis  ticklabel format general
-@    xaxis  ticklabel append ""
-@    xaxis  ticklabel prepend ""
-@    xaxis  ticklabel layout horizontal
-@    xaxis  ticklabel place on ticks
-@    xaxis  ticklabel skip 0
-@    xaxis  ticklabel stagger 0
-@    xaxis  ticklabel op bottom
-@    xaxis  ticklabel sign normal
-@    xaxis  ticklabel start type auto
-@    xaxis  ticklabel start 0.000000
-@    xaxis  ticklabel stop type auto
-@    xaxis  ticklabel stop 0.000000
-@    xaxis  ticklabel char size 0.600000
-@    xaxis  ticklabel font 4
-@    xaxis  ticklabel color 1
-@    xaxis  ticklabel linewidth 1
-@    xaxis  tick major on
-@    xaxis  tick minor on
-@    xaxis  tick default 6
-@    xaxis  tick in
-@    xaxis  tick major color 1
-@    xaxis  tick major linewidth 1
-@    xaxis  tick major linestyle 1
-@    xaxis  tick minor color 1
-@    xaxis  tick minor linewidth 1
-@    xaxis  tick minor linestyle 1
-@    xaxis  tick log off
-@    xaxis  tick size 1.000000
-@    xaxis  tick minor size 0.500000
-@    xaxis  bar off
-@    xaxis  bar color 1
-@    xaxis  bar linestyle 1
-@    xaxis  bar linewidth 1
-@    xaxis  tick major grid off
-@    xaxis  tick minor grid off
-@    xaxis  tick op both
-@    xaxis  tick type auto
-@    xaxis  tick spec 0
-@    yaxis  tick on
-@    yaxis  tick major 0.5
-@    yaxis  tick minor 0.25
-@    yaxis  tick offsetx 0.000000
-@    yaxis  tick offsety 0.000000
-@    yaxis  label "Order (2*Pi)"
-@    yaxis  label layout para
-@    yaxis  label place auto
-@    yaxis  label char size 0.600000
-@    yaxis  label font 4
-@    yaxis  label color 1
-@    yaxis  label linewidth 1
-@    yaxis  ticklabel on
-@    yaxis  ticklabel type auto
-@    yaxis  ticklabel prec 5
-@    yaxis  ticklabel format general
-@    yaxis  ticklabel append ""
-@    yaxis  ticklabel prepend ""
-@    yaxis  ticklabel layout horizontal
-@    yaxis  ticklabel place on ticks
-@    yaxis  ticklabel skip 0
-@    yaxis  ticklabel stagger 0
-@    yaxis  ticklabel op left
-@    yaxis  ticklabel sign normal
-@    yaxis  ticklabel start type auto
-@    yaxis  ticklabel start 0.000000
-@    yaxis  ticklabel stop type auto
-@    yaxis  ticklabel stop 0.000000
-@    yaxis  ticklabel char size 0.600000
-@    yaxis  ticklabel font 4
-@    yaxis  ticklabel color 1
-@    yaxis  ticklabel linewidth 1
-@    yaxis  tick major on
-@    yaxis  tick minor on
-@    yaxis  tick default 6
-@    yaxis  tick in
-@    yaxis  tick major color 1
-@    yaxis  tick major linewidth 1
-@    yaxis  tick major linestyle 1
-@    yaxis  tick minor color 1
-@    yaxis  tick minor linewidth 1
-@    yaxis  tick minor linestyle 1
-@    yaxis  tick log off
-@    yaxis  tick size 1.000000
-@    yaxis  tick minor size 0.500000
-@    yaxis  bar off
-@    yaxis  bar color 1
-@    yaxis  bar linestyle 1
-@    yaxis  bar linewidth 1
-@    yaxis  tick major grid off
-@    yaxis  tick minor grid off
-@    yaxis  tick op both
-@    yaxis  tick type auto
-@    yaxis  tick spec 0
-@    zeroxaxis  tick on
-@    zeroxaxis  tick major 1
-@    zeroxaxis  tick minor 0.5
-@    zeroxaxis  tick offsetx 0.000000
-@    zeroxaxis  tick offsety 0.000000
-@    zeroxaxis  label ""
-@    zeroxaxis  label layout para
-@    zeroxaxis  label place auto
-@    zeroxaxis  label char size 1.000000
-@    zeroxaxis  label font 4
-@    zeroxaxis  label color 1
-@    zeroxaxis  label linewidth 1
-@    zeroxaxis  ticklabel off
-@    zeroxaxis  ticklabel type auto
-@    zeroxaxis  ticklabel prec 5
-@    zeroxaxis  ticklabel format general
-@    zeroxaxis  ticklabel append ""
-@    zeroxaxis  ticklabel prepend ""
-@    zeroxaxis  ticklabel layout horizontal
-@    zeroxaxis  ticklabel place on ticks
-@    zeroxaxis  ticklabel skip 0
-@    zeroxaxis  ticklabel stagger 0
-@    zeroxaxis  ticklabel op bottom
-@    zeroxaxis  ticklabel sign normal
-@    zeroxaxis  ticklabel start type auto
-@    zeroxaxis  ticklabel start 0.000000
-@    zeroxaxis  ticklabel stop type auto
-@    zeroxaxis  ticklabel stop 0.000000
-@    zeroxaxis  ticklabel char size 0.610000
-@    zeroxaxis  ticklabel font 4
-@    zeroxaxis  ticklabel color 1
-@    zeroxaxis  ticklabel linewidth 1
-@    zeroxaxis  tick major off
-@    zeroxaxis  tick minor on
-@    zeroxaxis  tick default 6
-@    zeroxaxis  tick in
-@    zeroxaxis  tick major color 1
-@    zeroxaxis  tick major linewidth 1
-@    zeroxaxis  tick major linestyle 1
-@    zeroxaxis  tick minor color 1
-@    zeroxaxis  tick minor linewidth 1
-@    zeroxaxis  tick minor linestyle 1
-@    zeroxaxis  tick log off
-@    zeroxaxis  tick size 1.000000
-@    zeroxaxis  tick minor size 0.500000
-@    zeroxaxis  bar off
-@    zeroxaxis  bar color 1
-@    zeroxaxis  bar linestyle 1
-@    zeroxaxis  bar linewidth 1
-@    zeroxaxis  tick major grid off
-@    zeroxaxis  tick minor grid off
-@    zeroxaxis  tick op both
-@    zeroxaxis  tick type auto
-@    zeroxaxis  tick spec 0
-@    zeroyaxis  tick on
-@    zeroyaxis  tick major 0.5
-@    zeroyaxis  tick minor 0.25
-@    zeroyaxis  tick offsetx 0.000000
-@    zeroyaxis  tick offsety 0.000000
-@    zeroyaxis  label ""
-@    zeroyaxis  label layout para
-@    zeroyaxis  label place auto
-@    zeroyaxis  label char size 1.000000
-@    zeroyaxis  label font 4
-@    zeroyaxis  label color 1
-@    zeroyaxis  label linewidth 1
-@    zeroyaxis  ticklabel off
-@    zeroyaxis  ticklabel type auto
-@    zeroyaxis  ticklabel prec 5
-@    zeroyaxis  ticklabel format general
-@    zeroyaxis  ticklabel append ""
-@    zeroyaxis  ticklabel prepend ""
-@    zeroyaxis  ticklabel layout horizontal
-@    zeroyaxis  ticklabel place on ticks
-@    zeroyaxis  ticklabel skip 0
-@    zeroyaxis  ticklabel stagger 0
-@    zeroyaxis  ticklabel op left
-@    zeroyaxis  ticklabel sign normal
-@    zeroyaxis  ticklabel start type auto
-@    zeroyaxis  ticklabel start 0.000000
-@    zeroyaxis  ticklabel stop type auto
-@    zeroyaxis  ticklabel stop 0.000000
-@    zeroyaxis  ticklabel char size 0.610000
-@    zeroyaxis  ticklabel font 4
-@    zeroyaxis  ticklabel color 1
-@    zeroyaxis  ticklabel linewidth 1
-@    zeroyaxis  tick major off
-@    zeroyaxis  tick minor on
-@    zeroyaxis  tick default 6
-@    zeroyaxis  tick in
-@    zeroyaxis  tick major color 1
-@    zeroyaxis  tick major linewidth 1
-@    zeroyaxis  tick major linestyle 1
-@    zeroyaxis  tick minor color 1
-@    zeroyaxis  tick minor linewidth 1
-@    zeroyaxis  tick minor linestyle 1
-@    zeroyaxis  tick log off
-@    zeroyaxis  tick size 1.000000
-@    zeroyaxis  tick minor size 0.500000
-@    zeroyaxis  bar off
-@    zeroyaxis  bar color 1
-@    zeroyaxis  bar linestyle 1
-@    zeroyaxis  bar linewidth 1
-@    zeroyaxis  tick major grid off
-@    zeroyaxis  tick minor grid off
-@    zeroyaxis  tick op both
-@    zeroyaxis  tick type auto
-@    zeroyaxis  tick spec 0
-@    legend on
-@    legend loctype view
-@    legend layout 0
-@    legend vgap 2
-@    legend hgap 1
-@    legend length 4
-@    legend box off
-@    legend box fill off
-@    legend box fill with color
-@    legend box fill color 0
-@    legend box fill pattern 1
-@    legend box color 1
-@    legend box linewidth 1
-@    legend box linestyle 1
-@    legend x1 0.61
-@    legend y1 0.91
-@    legend font 4
-@    legend char size 0.450000
-@    legend linestyle 1
-@    legend linewidth 1
-@    legend color 1
-@    legend string 0 "first"
-@    legend string 1 "second"
-@    legend string 2 "infinite"
-@    frame on
-@    frame type 0
-@    frame linestyle 1
-@    frame linewidth 1
-@    frame color 1
-@    frame fill off
-@    frame background color 0
- at WITH G0
- at G0 ON
- at TARGET S0
- at TYPE xy
-               3        0.0387032
-               4        0.0352252
-               5        0.0255154
-               6       0.00849857
-               7       0.00178739
-               8      0.000394958
-&
- at TARGET S1
- at TYPE xy
-               3        0.0657548
-               4        0.0725134
-               5        0.0532922
-               6        0.0173997
-               7       0.00351869
-               8      0.000755044
-&
- at TARGET S2
- at TYPE xy
-               3         0.238889
-               4          0.39572
-               5         0.360163
-               6           0.1232
-               7        0.0244415
-               8       0.00485213
-&
- at WITH G1
- at G1 ON
- at TARGET S0
- at TYPE xy
-               4          1.04821
-               5          1.17497
-               6          1.73272
-               7          2.18054
-               8          2.12733
-&
- at TARGET S1
- at TYPE xy
-               4         0.952258
-               5          1.16648
-               6          1.75009
-               7          2.22372
-               8          2.15876
-&
- at TARGET S2
- at TYPE xy
-               4          0.77697
-               5           1.0482
-               6           1.7098
-               7          2.24513
-               8          2.24439
-&
- at WITH G2
- at G2 ON
- at TARGET S0
- at TYPE xy
-               3        0.0557821
-               4        0.0379515
-               5        0.0305179
-               6        0.0145614
-               7       0.00348141
-               8      0.000787213
-&
- at TARGET S1
- at TYPE xy
-               3        0.0865555
-               4        0.0772393
-               5        0.0641095
-               6        0.0296009
-               7       0.00686286
-               8       0.00150512
-&
- at TARGET S2
- at TYPE xy
-               3          0.30913
-               4         0.448196
-               5         0.437962
-               6         0.210648
-               7        0.0477525
-               8       0.00969868
-&
- at WITH G3
- at G3 ON
- at TARGET S0
- at TYPE xy
-               4          1.21236
-               5          1.11516
-               6          1.44769
-               7          2.04514
-               8          2.10296
-&
- at TARGET S1
- at TYPE xy
-               4          1.05859
-               5          1.09764
-               6          1.47166
-               7          2.07682
-               8          2.13534
-&
- at TARGET S2
- at TYPE xy
-               4         0.830494
-               5          1.01162
-               6          1.44191
-               7           2.1003
-               8          2.21892
-&
diff --git a/test/advection/order/report.sh b/test/advection/order/report.sh
index d2e1fd6..94e579f 100755
--- a/test/advection/order/report.sh
+++ b/test/advection/order/report.sh
@@ -2,17 +2,10 @@
 # $1: test files
 
 if test -z "$1"; then
-    echo "usage: report.sh REFERENCES"
-    echo "  REFERENCES: reference xmgr files. example: \"reference/*.xmgr\""
+    echo "usage: report.sh DIRECTORIES"
     exit 1;
 fi
 
-if test -e figures; then 
-    :
-else
-    mkdir figures;
-fi
-
 texfile=report
 cat <<EOF > $texfile.tex
 \documentclass[a4paper,11pt]{article}
@@ -32,7 +25,7 @@ cat <<EOF > $texfile.tex
 \vspace{5mm}
 EOF
 
-../advection -V 2>&1 | awk '{print $0 "\\\\"}' >> $texfile.tex
+gerris2D -V 2>&1 | awk '{print $0 "\\\\"}' >> $texfile.tex
 echo "`uname -a` \\\\" >> $texfile.tex
 echo "Total running time: `cat timestamp` s\\\\" >> $texfile.tex
 
@@ -45,24 +38,15 @@ cat <<EOF >> $texfile.tex
 EOF
 
 for file in $1; do
-    testfile=test/`basename $file`
-    sname=`basename $file | awk '{print substr ($1, 1, index ($1, ".") - 1)}'`
-    xmgrace -hardcopy -noask -hdevice EPS -printfile figures/$sname.eps -p order.par $file $testfile
+    xmgrace -hardcopy -noask -hdevice EPS -printfile $file/result.eps -p order.par $file/reference.xmgr $file/result.xmgr
     echo "\\begin{figure}" >> $texfile.tex
     echo "\\begin{center}" >> $texfile.tex
-    echo "\\psfig{file=figures/$sname.eps, height=\\hsize, angle=270}" >> $texfile.tex
+    echo "\\psfig{file=$file/result.eps, width=0.8\\hsize}" >> $texfile.tex
     echo "\\end{center}" >> $texfile.tex
-    esname=`echo $sname | awk 'BEGIN{FS=""}{for (i = 1; i <= NF; i++)if($i=="_")printf("\\\_"); else printf("%s", $i);}'`
-    command=`awk '\
-	BEGIN{ FS=" |\""; }\
-	{\
-	    if ($1 == "@description") {\
-		for (i = 3; i <= NF; i++)\
-		    printf ("%s ", $i);\
-		exit 0;\
-	    }\
-	}\' < $file`
-    echo "\\caption{$esname: {\tt $command}}" >> $texfile.tex
+    esname=`basename $file | awk 'BEGIN{FS=""}{for (i = 1; i <= NF; i++)if($i=="_")printf("\\\_"); else printf("%s", $i);}'`
+    echo "\\caption{$esname: " >> $texfile.tex
+    cat $file/description.tex >> $texfile.tex
+    echo "}" >> $texfile.tex
     echo "\\end{figure}" >> $texfile.tex
     echo "\\clearpage" >> $texfile.tex
 done
@@ -70,4 +54,4 @@ echo "\\end{document}" >> $texfile.tex
 latex -interaction=nonstopmode $texfile.tex > /dev/null 2>&1
 latex -interaction=nonstopmode $texfile.tex > /dev/null 2>&1
 dvips $texfile.dvi -o $texfile.ps > /dev/null 2>&1
-rm -f $texfile.log $texfile.aux $texfile.dvi
+rm -f $texfile.log $texfile.aux $texfile.dvi $texfile.lof $texfile.tex
diff --git a/test/advection/order/tests/rotate1/advection.gfs b/test/advection/order/tests/rotate1/advection.gfs
new file mode 100644
index 0000000..15c15e5
--- /dev/null
+++ b/test/advection/order/tests/rotate1/advection.gfs
@@ -0,0 +1,25 @@
+1 0 GfsAdvection GfsBox GfsGEdge {} {
+  Time { end = 0.785398 }
+  Refine LEVEL
+  VariableTracer {} T {
+    gradient = gfs_center_gradient
+  }
+  AdvectionParams { cfl = 0.5 }
+  Init {} {
+    U = -8.*y
+    V = 8.*x
+    T = {
+      double r2 = x*x + y*y; 
+      double coeff = 20. + 20000.*r2*r2*r2*r2;
+      return (1. + cos(20.*x)*cos(20.*y))*exp(-coeff*r2)/2.;
+    }
+  }
+  OutputErrorNorm { start = end } { awk '{ print LEVEL " " $5 " " $7 " " $9}' } { v = T } {
+    s = {
+      double r2 = x*x + y*y; 
+      double coeff = 20. + 20000.*r2*r2*r2*r2;
+      return (1. + cos(20.*x)*cos(20.*y))*exp(-coeff*r2)/2.;
+    }
+  }
+}
+GfsBox {}
diff --git a/test/advection/order/tests/rotate1/description.tex b/test/advection/order/tests/rotate1/description.tex
new file mode 100644
index 0000000..8e1ec7c
--- /dev/null
+++ b/test/advection/order/tests/rotate1/description.tex
@@ -0,0 +1 @@
+Rotation of a smooth field (``gaussian''), no limiter, CFL of 0.5.
diff --git a/test/advection/order/tests/rotate1/reference.xmgr b/test/advection/order/tests/rotate1/reference.xmgr
new file mode 100644
index 0000000..ba58591
--- /dev/null
+++ b/test/advection/order/tests/rotate1/reference.xmgr
@@ -0,0 +1,805 @@
+# Grace project file
+#
+ at version 50118
+ at page size 792, 612
+ at description "advection -n -s"
+ at page scroll 5%
+ at page inout 5%
+ at link page off
+ at map font 10 to "Courier-BoldOblique", "Courier-BoldOblique"
+ at map font 11 to "Courier-Oblique", "Courier-Oblique"
+ at map font 4 to "Helvetica", "Helvetica"
+ at map font 5 to "Helvetica-Bold", "Helvetica-Bold"
+ at map font 7 to "Helvetica-BoldOblique", "Helvetica-BoldOblique"
+ at map font 15 to "Helvetica-Narrow", "Helvetica-Narrow"
+ at map font 16 to "Helvetica-Narrow-Bold", "Helvetica-Narrow-Bold"
+ at map font 17 to "Helvetica-Narrow-BoldOblique", "Helvetica-Narrow-BoldOblique"
+ at map font 18 to "Helvetica-Narrow-Oblique", "Helvetica-Narrow-Oblique"
+ at map font 6 to "Helvetica-Oblique", "Helvetica-Oblique"
+ at map font 20 to "NewCenturySchlbk-Bold", "NewCenturySchlbk-Bold"
+ at map font 21 to "NewCenturySchlbk-BoldItalic", "NewCenturySchlbk-BoldItalic"
+ at map font 22 to "NewCenturySchlbk-Italic", "NewCenturySchlbk-Italic"
+ at map font 23 to "NewCenturySchlbk-Roman", "NewCenturySchlbk-Roman"
+ at map font 24 to "Palatino-Bold", "Palatino-Bold"
+ at map font 25 to "Palatino-BoldItalic", "Palatino-BoldItalic"
+ at map font 26 to "Palatino-Italic", "Palatino-Italic"
+ at map font 27 to "Palatino-Roman", "Palatino-Roman"
+ at map font 8 to "Symbol", "Symbol"
+ at map font 1 to "Times-Bold", "Times-Bold"
+ at map font 3 to "Times-BoldItalic", "Times-BoldItalic"
+ at map font 2 to "Times-Italic", "Times-Italic"
+ at map font 0 to "Times-Roman", "Times-Roman"
+ at map font 33 to "ZapfChancery-MediumItalic", "ZapfChancery-MediumItalic"
+ at map font 9 to "ZapfDingbats", "ZapfDingbats"
+ at map color 0 to (255, 255, 255), "white"
+ at map color 1 to (0, 0, 0), "black"
+ at map color 2 to (255, 0, 0), "red"
+ at map color 3 to (0, 255, 0), "green"
+ at map color 4 to (0, 0, 255), "blue"
+ at map color 5 to (255, 255, 0), "yellow"
+ at map color 6 to (188, 143, 143), "brown"
+ at map color 7 to (220, 220, 220), "grey"
+ at map color 8 to (148, 0, 211), "violet"
+ at map color 9 to (0, 255, 255), "cyan"
+ at map color 10 to (255, 0, 255), "magenta"
+ at map color 11 to (255, 165, 0), "orange"
+ at map color 12 to (114, 33, 188), "indigo"
+ at map color 13 to (103, 7, 72), "maroon"
+ at map color 14 to (64, 224, 208), "turquoise"
+ at map color 15 to (0, 139, 0), "green4"
+ at reference date 0
+ at date wrap on
+ at date wrap year 1900
+ at default linewidth 1.0
+ at default linestyle 1
+ at default color 1
+ at default pattern 1
+ at default font 4
+ at default char size 1.000000
+ at default symbol size 1.000000
+ at default sformat "%.8g"
+ at background color 0
+ at page background fill on
+ at timestamp off
+ at timestamp 0.03, 0.03
+ at timestamp color 1
+ at timestamp rot 0
+ at timestamp font 4
+ at timestamp char size 1.000000
+ at timestamp def "Thu May 26 18:01:25 2005"
+ at r0 off
+ at link r0 to g0
+ at r0 type above
+ at r0 linestyle 1
+ at r0 linewidth 1.0
+ at r0 color 1
+ at r0 line 0, 0, 0, 0
+ at r1 off
+ at link r1 to g0
+ at r1 type above
+ at r1 linestyle 1
+ at r1 linewidth 1.0
+ at r1 color 1
+ at r1 line 0, 0, 0, 0
+ at r2 off
+ at link r2 to g0
+ at r2 type above
+ at r2 linestyle 1
+ at r2 linewidth 1.0
+ at r2 color 1
+ at r2 line 0, 0, 0, 0
+ at r3 off
+ at link r3 to g0
+ at r3 type above
+ at r3 linestyle 1
+ at r3 linewidth 1.0
+ at r3 color 1
+ at r3 line 0, 0, 0, 0
+ at r4 off
+ at link r4 to g0
+ at r4 type above
+ at r4 linestyle 1
+ at r4 linewidth 1.0
+ at r4 color 1
+ at r4 line 0, 0, 0, 0
+ at g0 on
+ at g0 hidden false
+ at g0 type XY
+ at g0 stacked false
+ at g0 bar hgap 0.000000
+ at g0 fixedpoint off
+ at g0 fixedpoint type 0
+ at g0 fixedpoint xy 0.000000, 0.000000
+ at g0 fixedpoint format general general
+ at g0 fixedpoint prec 6, 6
+ at with g0
+@    world 3, 0.0001, 8, 1
+@    stack world 0, 0, 0, 0
+@    znorm 1
+@    view 0.129310, 0.100000, 0.614224, 0.475000
+@    title ""
+@    title font 4
+@    title size 1.500000
+@    title color 1
+@    subtitle ""
+@    subtitle font 4
+@    subtitle size 1.000000
+@    subtitle color 1
+@    xaxes scale Normal
+@    yaxes scale Logarithmic
+@    xaxes invert off
+@    yaxes invert off
+@    xaxis  on
+@    xaxis  type zero false
+@    xaxis  offset 0.000000 , 0.000000
+@    xaxis  bar off
+@    xaxis  bar color 1
+@    xaxis  bar linestyle 1
+@    xaxis  bar linewidth 1.0
+@    xaxis  label "Level"
+@    xaxis  label layout para
+@    xaxis  label place auto
+@    xaxis  label char size 0.600000
+@    xaxis  label font 4
+@    xaxis  label color 1
+@    xaxis  label place normal
+@    xaxis  tick on
+@    xaxis  tick major 1
+@    xaxis  tick minor ticks 1
+@    xaxis  tick default 6
+@    xaxis  tick place rounded true
+@    xaxis  tick in
+@    xaxis  tick major size 1.000000
+@    xaxis  tick major color 1
+@    xaxis  tick major linewidth 1.0
+@    xaxis  tick major linestyle 1
+@    xaxis  tick major grid off
+@    xaxis  tick minor color 1
+@    xaxis  tick minor linewidth 1.0
+@    xaxis  tick minor linestyle 1
+@    xaxis  tick minor grid off
+@    xaxis  tick minor size 0.500000
+@    xaxis  ticklabel on
+@    xaxis  ticklabel format general
+@    xaxis  ticklabel prec 5
+@    xaxis  ticklabel formula ""
+@    xaxis  ticklabel append ""
+@    xaxis  ticklabel prepend ""
+@    xaxis  ticklabel angle 0
+@    xaxis  ticklabel skip 0
+@    xaxis  ticklabel stagger 0
+@    xaxis  ticklabel place normal
+@    xaxis  ticklabel offset auto
+@    xaxis  ticklabel offset 0.000000 , 0.010000
+@    xaxis  ticklabel start type auto
+@    xaxis  ticklabel start 0.000000
+@    xaxis  ticklabel stop type auto
+@    xaxis  ticklabel stop 0.000000
+@    xaxis  ticklabel char size 0.600000
+@    xaxis  ticklabel font 4
+@    xaxis  ticklabel color 1
+@    xaxis  tick place both
+@    xaxis  tick spec type none
+@    yaxis  on
+@    yaxis  type zero false
+@    yaxis  offset 0.000000 , 0.000000
+@    yaxis  bar off
+@    yaxis  bar color 1
+@    yaxis  bar linestyle 1
+@    yaxis  bar linewidth 1.0
+@    yaxis  label "Error"
+@    yaxis  label layout para
+@    yaxis  label place auto
+@    yaxis  label char size 0.600000
+@    yaxis  label font 4
+@    yaxis  label color 1
+@    yaxis  label place normal
+@    yaxis  tick on
+@    yaxis  tick major 10
+@    yaxis  tick minor ticks 0
+@    yaxis  tick default 6
+@    yaxis  tick place rounded true
+@    yaxis  tick in
+@    yaxis  tick major size 1.000000
+@    yaxis  tick major color 1
+@    yaxis  tick major linewidth 1.0
+@    yaxis  tick major linestyle 3
+@    yaxis  tick major grid on
+@    yaxis  tick minor color 1
+@    yaxis  tick minor linewidth 1.0
+@    yaxis  tick minor linestyle 1
+@    yaxis  tick minor grid off
+@    yaxis  tick minor size 0.500000
+@    yaxis  ticklabel on
+@    yaxis  ticklabel format general
+@    yaxis  ticklabel prec 0
+@    yaxis  ticklabel formula ""
+@    yaxis  ticklabel append ""
+@    yaxis  ticklabel prepend ""
+@    yaxis  ticklabel angle 0
+@    yaxis  ticklabel skip 0
+@    yaxis  ticklabel stagger 0
+@    yaxis  ticklabel place normal
+@    yaxis  ticklabel offset auto
+@    yaxis  ticklabel offset 0.000000 , 0.010000
+@    yaxis  ticklabel start type auto
+@    yaxis  ticklabel start 0.000000
+@    yaxis  ticklabel stop type auto
+@    yaxis  ticklabel stop 0.000000
+@    yaxis  ticklabel char size 0.590000
+@    yaxis  ticklabel font 4
+@    yaxis  ticklabel color 1
+@    yaxis  tick place both
+@    yaxis  tick spec type none
+@    altxaxis  off
+@    altyaxis  off
+@    legend on
+@    legend loctype view
+@    legend 0.181034482759, 0.25
+@    legend box color 1
+@    legend box pattern 0
+@    legend box linewidth 1.0
+@    legend box linestyle 1
+@    legend box fill color 0
+@    legend box fill pattern 1
+@    legend font 4
+@    legend char size 0.460000
+@    legend color 1
+@    legend length 4
+@    legend vgap 1
+@    legend hgap 1
+@    legend invert false
+@    frame type 0
+@    frame linestyle 1
+@    frame linewidth 1.0
+@    frame color 1
+@    frame pattern 1
+@    frame background color 0
+@    frame background pattern 0
+@    s0 hidden false
+@    s0 type xy
+@    s0 symbol 1
+@    s0 symbol size 0.340000
+@    s0 symbol color 1
+@    s0 symbol pattern 1
+@    s0 symbol fill color 1
+@    s0 symbol fill pattern 1
+@    s0 symbol linewidth 1.0
+@    s0 symbol linestyle 1
+@    s0 symbol char 0
+@    s0 symbol char font 4
+@    s0 symbol skip 0
+@    s0 line type 1
+@    s0 line linestyle 1
+@    s0 line linewidth 1.0
+@    s0 line color 1
+@    s0 line pattern 1
+@    s0 baseline type 0
+@    s0 baseline off
+@    s0 dropline off
+@    s0 fill type 0
+@    s0 fill rule 0
+@    s0 fill color 1
+@    s0 fill pattern 1
+@    s0 avalue off
+@    s0 avalue type 2
+@    s0 avalue char size 1.000000
+@    s0 avalue font 4
+@    s0 avalue color 1
+@    s0 avalue rot 0
+@    s0 avalue format general
+@    s0 avalue prec 3
+@    s0 avalue prepend ""
+@    s0 avalue append ""
+@    s0 avalue offset 0.000000 , 0.000000
+@    s0 errorbar on
+@    s0 errorbar place both
+@    s0 errorbar color 1
+@    s0 errorbar pattern 1
+@    s0 errorbar size 2.000000
+@    s0 errorbar linewidth 1.0
+@    s0 errorbar linestyle 1
+@    s0 errorbar riser linewidth 1.0
+@    s0 errorbar riser linestyle 1
+@    s0 errorbar riser clip off
+@    s0 errorbar riser clip length 0.100000
+@    s0 comment "/tmp/toto"
+@    s0 legend  "first"
+@    s1 hidden false
+@    s1 type xy
+@    s1 symbol 2
+@    s1 symbol size 0.440000
+@    s1 symbol color 1
+@    s1 symbol pattern 1
+@    s1 symbol fill color 1
+@    s1 symbol fill pattern 1
+@    s1 symbol linewidth 1.0
+@    s1 symbol linestyle 1
+@    s1 symbol char 0
+@    s1 symbol char font 4
+@    s1 symbol skip 0
+@    s1 line type 1
+@    s1 line linestyle 1
+@    s1 line linewidth 1.0
+@    s1 line color 1
+@    s1 line pattern 1
+@    s1 baseline type 0
+@    s1 baseline off
+@    s1 dropline off
+@    s1 fill type 0
+@    s1 fill rule 0
+@    s1 fill color 1
+@    s1 fill pattern 1
+@    s1 avalue off
+@    s1 avalue type 2
+@    s1 avalue char size 1.000000
+@    s1 avalue font 4
+@    s1 avalue color 1
+@    s1 avalue rot 0
+@    s1 avalue format general
+@    s1 avalue prec 3
+@    s1 avalue prepend ""
+@    s1 avalue append ""
+@    s1 avalue offset 0.000000 , 0.000000
+@    s1 errorbar on
+@    s1 errorbar place both
+@    s1 errorbar color 1
+@    s1 errorbar pattern 1
+@    s1 errorbar size 2.000000
+@    s1 errorbar linewidth 1.0
+@    s1 errorbar linestyle 1
+@    s1 errorbar riser linewidth 1.0
+@    s1 errorbar riser linestyle 1
+@    s1 errorbar riser clip off
+@    s1 errorbar riser clip length 0.100000
+@    s1 comment "/tmp/toto"
+@    s1 legend  "second"
+@    s2 hidden false
+@    s2 type xy
+@    s2 symbol 4
+@    s2 symbol size 0.340000
+@    s2 symbol color 1
+@    s2 symbol pattern 1
+@    s2 symbol fill color 1
+@    s2 symbol fill pattern 1
+@    s2 symbol linewidth 1.0
+@    s2 symbol linestyle 1
+@    s2 symbol char 0
+@    s2 symbol char font 4
+@    s2 symbol skip 0
+@    s2 line type 1
+@    s2 line linestyle 1
+@    s2 line linewidth 1.0
+@    s2 line color 1
+@    s2 line pattern 1
+@    s2 baseline type 0
+@    s2 baseline off
+@    s2 dropline off
+@    s2 fill type 0
+@    s2 fill rule 0
+@    s2 fill color 1
+@    s2 fill pattern 1
+@    s2 avalue off
+@    s2 avalue type 2
+@    s2 avalue char size 1.000000
+@    s2 avalue font 4
+@    s2 avalue color 1
+@    s2 avalue rot 0
+@    s2 avalue format general
+@    s2 avalue prec 3
+@    s2 avalue prepend ""
+@    s2 avalue append ""
+@    s2 avalue offset 0.000000 , 0.000000
+@    s2 errorbar on
+@    s2 errorbar place both
+@    s2 errorbar color 1
+@    s2 errorbar pattern 1
+@    s2 errorbar size 2.000000
+@    s2 errorbar linewidth 1.0
+@    s2 errorbar linestyle 1
+@    s2 errorbar riser linewidth 1.0
+@    s2 errorbar riser linestyle 1
+@    s2 errorbar riser clip off
+@    s2 errorbar riser clip length 0.100000
+@    s2 comment "/tmp/toto"
+@    s2 legend  "infinite"
+ at g1 on
+ at g1 hidden false
+ at g1 type XY
+ at g1 stacked false
+ at g1 bar hgap 0.000000
+ at g1 fixedpoint off
+ at g1 fixedpoint type 0
+ at g1 fixedpoint xy 0.000000, 0.000000
+ at g1 fixedpoint format general general
+ at g1 fixedpoint prec 6, 6
+ at with g1
+@    world 4, -1, 8, 2.5
+@    stack world 0, 0, 0, 0
+@    znorm 1
+@    view 0.129310, 0.575000, 0.614224, 0.950000
+@    title ""
+@    title font 4
+@    title size 1.500000
+@    title color 1
+@    subtitle ""
+@    subtitle font 4
+@    subtitle size 1.000000
+@    subtitle color 1
+@    xaxes scale Normal
+@    yaxes scale Normal
+@    xaxes invert off
+@    yaxes invert off
+@    xaxis  on
+@    xaxis  type zero false
+@    xaxis  offset 0.000000 , 0.000000
+@    xaxis  bar off
+@    xaxis  bar color 1
+@    xaxis  bar linestyle 1
+@    xaxis  bar linewidth 1.0
+@    xaxis  label "Level"
+@    xaxis  label layout para
+@    xaxis  label place auto
+@    xaxis  label char size 0.600000
+@    xaxis  label font 4
+@    xaxis  label color 1
+@    xaxis  label place normal
+@    xaxis  tick on
+@    xaxis  tick major 1
+@    xaxis  tick minor ticks 1
+@    xaxis  tick default 6
+@    xaxis  tick place rounded true
+@    xaxis  tick in
+@    xaxis  tick major size 1.000000
+@    xaxis  tick major color 1
+@    xaxis  tick major linewidth 1.0
+@    xaxis  tick major linestyle 1
+@    xaxis  tick major grid off
+@    xaxis  tick minor color 1
+@    xaxis  tick minor linewidth 1.0
+@    xaxis  tick minor linestyle 1
+@    xaxis  tick minor grid off
+@    xaxis  tick minor size 0.500000
+@    xaxis  ticklabel on
+@    xaxis  ticklabel format general
+@    xaxis  ticklabel prec 5
+@    xaxis  ticklabel formula ""
+@    xaxis  ticklabel append ""
+@    xaxis  ticklabel prepend ""
+@    xaxis  ticklabel angle 0
+@    xaxis  ticklabel skip 0
+@    xaxis  ticklabel stagger 0
+@    xaxis  ticklabel place normal
+@    xaxis  ticklabel offset auto
+@    xaxis  ticklabel offset 0.000000 , 0.010000
+@    xaxis  ticklabel start type auto
+@    xaxis  ticklabel start 0.000000
+@    xaxis  ticklabel stop type auto
+@    xaxis  ticklabel stop 0.000000
+@    xaxis  ticklabel char size 0.600000
+@    xaxis  ticklabel font 4
+@    xaxis  ticklabel color 1
+@    xaxis  tick place both
+@    xaxis  tick spec type none
+@    yaxis  on
+@    yaxis  type zero false
+@    yaxis  offset 0.000000 , 0.000000
+@    yaxis  bar off
+@    yaxis  bar color 1
+@    yaxis  bar linestyle 1
+@    yaxis  bar linewidth 1.0
+@    yaxis  label "Order"
+@    yaxis  label layout para
+@    yaxis  label place auto
+@    yaxis  label char size 0.600000
+@    yaxis  label font 4
+@    yaxis  label color 1
+@    yaxis  label place normal
+@    yaxis  tick on
+@    yaxis  tick major 0.5
+@    yaxis  tick minor ticks 1
+@    yaxis  tick default 6
+@    yaxis  tick place rounded true
+@    yaxis  tick in
+@    yaxis  tick major size 1.000000
+@    yaxis  tick major color 1
+@    yaxis  tick major linewidth 1.0
+@    yaxis  tick major linestyle 3
+@    yaxis  tick major grid off
+@    yaxis  tick minor color 1
+@    yaxis  tick minor linewidth 1.0
+@    yaxis  tick minor linestyle 1
+@    yaxis  tick minor grid off
+@    yaxis  tick minor size 0.500000
+@    yaxis  ticklabel on
+@    yaxis  ticklabel format general
+@    yaxis  ticklabel prec 5
+@    yaxis  ticklabel formula ""
+@    yaxis  ticklabel append ""
+@    yaxis  ticklabel prepend ""
+@    yaxis  ticklabel angle 0
+@    yaxis  ticklabel skip 0
+@    yaxis  ticklabel stagger 0
+@    yaxis  ticklabel place normal
+@    yaxis  ticklabel offset auto
+@    yaxis  ticklabel offset 0.000000 , 0.010000
+@    yaxis  ticklabel start type auto
+@    yaxis  ticklabel start 0.000000
+@    yaxis  ticklabel stop type auto
+@    yaxis  ticklabel stop 0.000000
+@    yaxis  ticklabel char size 0.600000
+@    yaxis  ticklabel font 4
+@    yaxis  ticklabel color 1
+@    yaxis  tick place both
+@    yaxis  tick spec type none
+@    altxaxis  off
+@    altyaxis  off
+@    legend on
+@    legend loctype view
+@    legend 0.4, 0.75
+@    legend box color 1
+@    legend box pattern 0
+@    legend box linewidth 1.0
+@    legend box linestyle 1
+@    legend box fill color 0
+@    legend box fill pattern 1
+@    legend font 4
+@    legend char size 0.460000
+@    legend color 1
+@    legend length 4
+@    legend vgap 1
+@    legend hgap 1
+@    legend invert false
+@    frame type 0
+@    frame linestyle 1
+@    frame linewidth 1.0
+@    frame color 1
+@    frame pattern 1
+@    frame background color 0
+@    frame background pattern 0
+@    s0 hidden false
+@    s0 type xy
+@    s0 symbol 1
+@    s0 symbol size 0.340000
+@    s0 symbol color 1
+@    s0 symbol pattern 1
+@    s0 symbol fill color 1
+@    s0 symbol fill pattern 1
+@    s0 symbol linewidth 1.0
+@    s0 symbol linestyle 1
+@    s0 symbol char 0
+@    s0 symbol char font 4
+@    s0 symbol skip 0
+@    s0 line type 1
+@    s0 line linestyle 1
+@    s0 line linewidth 1.0
+@    s0 line color 1
+@    s0 line pattern 1
+@    s0 baseline type 0
+@    s0 baseline off
+@    s0 dropline off
+@    s0 fill type 0
+@    s0 fill rule 0
+@    s0 fill color 1
+@    s0 fill pattern 1
+@    s0 avalue off
+@    s0 avalue type 2
+@    s0 avalue char size 1.000000
+@    s0 avalue font 4
+@    s0 avalue color 1
+@    s0 avalue rot 0
+@    s0 avalue format general
+@    s0 avalue prec 3
+@    s0 avalue prepend ""
+@    s0 avalue append ""
+@    s0 avalue offset 0.000000 , 0.000000
+@    s0 errorbar on
+@    s0 errorbar place both
+@    s0 errorbar color 1
+@    s0 errorbar pattern 1
+@    s0 errorbar size 2.000000
+@    s0 errorbar linewidth 1.0
+@    s0 errorbar linestyle 1
+@    s0 errorbar riser linewidth 1.0
+@    s0 errorbar riser linestyle 1
+@    s0 errorbar riser clip off
+@    s0 errorbar riser clip length 0.100000
+@    s0 comment "/tmp/toto"
+@    s0 legend  "first"
+@    s1 hidden false
+@    s1 type xy
+@    s1 symbol 2
+@    s1 symbol size 0.440000
+@    s1 symbol color 1
+@    s1 symbol pattern 1
+@    s1 symbol fill color 1
+@    s1 symbol fill pattern 1
+@    s1 symbol linewidth 1.0
+@    s1 symbol linestyle 1
+@    s1 symbol char 0
+@    s1 symbol char font 4
+@    s1 symbol skip 0
+@    s1 line type 1
+@    s1 line linestyle 1
+@    s1 line linewidth 1.0
+@    s1 line color 1
+@    s1 line pattern 1
+@    s1 baseline type 0
+@    s1 baseline off
+@    s1 dropline off
+@    s1 fill type 0
+@    s1 fill rule 0
+@    s1 fill color 1
+@    s1 fill pattern 1
+@    s1 avalue off
+@    s1 avalue type 2
+@    s1 avalue char size 1.000000
+@    s1 avalue font 4
+@    s1 avalue color 1
+@    s1 avalue rot 0
+@    s1 avalue format general
+@    s1 avalue prec 3
+@    s1 avalue prepend ""
+@    s1 avalue append ""
+@    s1 avalue offset 0.000000 , 0.000000
+@    s1 errorbar on
+@    s1 errorbar place both
+@    s1 errorbar color 1
+@    s1 errorbar pattern 1
+@    s1 errorbar size 2.000000
+@    s1 errorbar linewidth 1.0
+@    s1 errorbar linestyle 1
+@    s1 errorbar riser linewidth 1.0
+@    s1 errorbar riser linestyle 1
+@    s1 errorbar riser clip off
+@    s1 errorbar riser clip length 0.100000
+@    s1 comment "/tmp/toto"
+@    s1 legend  "second"
+@    s2 hidden false
+@    s2 type xy
+@    s2 symbol 4
+@    s2 symbol size 0.340000
+@    s2 symbol color 1
+@    s2 symbol pattern 1
+@    s2 symbol fill color 1
+@    s2 symbol fill pattern 1
+@    s2 symbol linewidth 1.0
+@    s2 symbol linestyle 1
+@    s2 symbol char 0
+@    s2 symbol char font 4
+@    s2 symbol skip 0
+@    s2 line type 1
+@    s2 line linestyle 1
+@    s2 line linewidth 1.0
+@    s2 line color 1
+@    s2 line pattern 1
+@    s2 baseline type 0
+@    s2 baseline off
+@    s2 dropline off
+@    s2 fill type 0
+@    s2 fill rule 0
+@    s2 fill color 1
+@    s2 fill pattern 1
+@    s2 avalue off
+@    s2 avalue type 2
+@    s2 avalue char size 1.000000
+@    s2 avalue font 4
+@    s2 avalue color 1
+@    s2 avalue rot 0
+@    s2 avalue format general
+@    s2 avalue prec 3
+@    s2 avalue prepend ""
+@    s2 avalue append ""
+@    s2 avalue offset 0.000000 , 0.000000
+@    s2 errorbar on
+@    s2 errorbar place both
+@    s2 errorbar color 1
+@    s2 errorbar pattern 1
+@    s2 errorbar size 2.000000
+@    s2 errorbar linewidth 1.0
+@    s2 errorbar linestyle 1
+@    s2 errorbar riser linewidth 1.0
+@    s2 errorbar riser linestyle 1
+@    s2 errorbar riser clip off
+@    s2 errorbar riser clip length 0.100000
+@    s2 comment "/tmp/toto"
+@    s2 legend  "infinite"
+ at g2 on
+ at g2 hidden true
+ at g2 type XY
+ at g2 stacked false
+ at g2 bar hgap 0.000000
+ at g2 fixedpoint off
+ at g2 fixedpoint type 0
+ at g2 fixedpoint xy 0.000000, 0.000000
+ at g2 fixedpoint format general general
+ at g2 fixedpoint prec 6, 6
+ at with g2
+@    world 3, 0.0001, 8, 1
+@    stack world 0, 0, 0, 0
+@    znorm 1
+@    view 0.743534, 0.100000, 1.228448, 0.475000
+@    title ""
+@    title font 4
+@    title size 1.500000
+@    title color 1
+@    subtitle ""
+@    subtitle font 4
+@    subtitle size 1.000000
+@    subtitle color 1
+@    xaxes scale Normal
+@    yaxes scale Logarithmic
+@    xaxes invert off
+@    yaxes invert off
+@    xaxis  off
+@    yaxis  off
+@    altxaxis  off
+@    altyaxis  off
+@    legend on
+@    legend loctype view
+@    legend 0.788793103448, 0.25
+@    legend box color 1
+@    legend box pattern 0
+@    legend box linewidth 1.0
+@    legend box linestyle 1
+@    legend box fill color 0
+@    legend box fill pattern 1
+@    legend font 4
+@    legend char size 0.460000
+@    legend color 1
+@    legend length 4
+@    legend vgap 1
+@    legend hgap 1
+@    legend invert false
+@    frame type 0
+@    frame linestyle 1
+@    frame linewidth 1.0
+@    frame color 1
+@    frame pattern 1
+@    frame background color 0
+@    frame background pattern 0
+ at target G0.S0
+ at type xy
+3 3.284e-02
+4 3.442e-02
+5 1.961e-02
+6 5.639e-03
+7 1.213e-03
+8 2.709e-04
+ at target G0.S1
+ at type xy
+3 5.236e-02
+4 6.530e-02
+5 3.836e-02
+6 1.115e-02
+7 2.477e-03
+8 5.785e-04
+ at target G0.S2
+ at type xy
+3 1.718e-01
+4 2.831e-01
+5 1.796e-01
+6 5.452e-02
+7 1.249e-02
+8 2.898e-03
+ at target G1.S0
+ at type xy
+4 -0.067793
+5 0.811658
+6 1.79808
+7 2.21686
+8 2.16275
+ at target G1.S1
+ at type xy
+4 -0.318618
+5 0.76748
+6 1.78256
+7 2.17038
+8 2.09821
+ at target G1.S2
+ at type xy
+4 -0.720582
+5 0.656524
+6 1.71993
+7 2.12601
+8 2.10764
diff --git a/test/advection/graphic/tests/translate1/advection.gfs b/test/advection/order/tests/translate1/advection.gfs
similarity index 52%
copy from test/advection/graphic/tests/translate1/advection.gfs
copy to test/advection/order/tests/translate1/advection.gfs
index a7edd80..6fdb029 100644
--- a/test/advection/graphic/tests/translate1/advection.gfs
+++ b/test/advection/order/tests/translate1/advection.gfs
@@ -1,6 +1,6 @@
 1 2 GfsAdvection GfsBox GfsGEdge {} {
-  Time { end = 8.94427191 }
-  Refine 6
+  Time { end = 2.236067 }
+  Refine LEVEL
   VariableTracer {} T {
     gradient = gfs_center_gradient
   }
@@ -14,14 +14,13 @@
       return (1. + cos(20.*x)*cos(20.*y))*exp(-coeff*r2)/2.;
     }
   }
-  OutputScalarStats { istep = 1 } log { v = T }
-  OutputScalarSum { istep = 1 } log { v = T }
-  OutputSimulation { step = 2.236067 } stdout { variables = T binary = 1 }
-  EventScript { step = 2.236067 } {
-    number=`echo $GfsTime | awk '{print int($1/2.236067+0.001)}'`
-    echo "Save t-$number.eps { format = EPS width = 400 height = 400 }" 
+  OutputErrorNorm { start = end } { awk '{ print LEVEL " " $5 " " $7 " " $9}' } { v = T } {
+    s = {
+      double r2 = x*x + y*y; 
+      double coeff = 20. + 20000.*r2*r2*r2*r2;
+      return (1. + cos(20.*x)*cos(20.*y))*exp(-coeff*r2)/2.;
+    }
   }
-  OutputProgress { istep = 1 } stderr
 }
 GfsBox {}
 1 1 right
diff --git a/test/advection/order/tests/translate1/description.tex b/test/advection/order/tests/translate1/description.tex
new file mode 100644
index 0000000..6ad3206
--- /dev/null
+++ b/test/advection/order/tests/translate1/description.tex
@@ -0,0 +1 @@
+Translation of a smooth field (``gaussian''), periodic boundary conditions, no limiter, CFL of 0.5.
diff --git a/test/advection/order/tests/translate1/reference.xmgr b/test/advection/order/tests/translate1/reference.xmgr
new file mode 100644
index 0000000..0354651
--- /dev/null
+++ b/test/advection/order/tests/translate1/reference.xmgr
@@ -0,0 +1,751 @@
+# Grace project file
+#
+ at version 50118
+ at page size 792, 612
+ at description "advection -n -s -t -p"
+ at page scroll 5%
+ at page inout 5%
+ at link page off
+ at map font 10 to "Courier-BoldOblique", "Courier-BoldOblique"
+ at map font 11 to "Courier-Oblique", "Courier-Oblique"
+ at map font 4 to "Helvetica", "Helvetica"
+ at map font 5 to "Helvetica-Bold", "Helvetica-Bold"
+ at map font 7 to "Helvetica-BoldOblique", "Helvetica-BoldOblique"
+ at map font 15 to "Helvetica-Narrow", "Helvetica-Narrow"
+ at map font 16 to "Helvetica-Narrow-Bold", "Helvetica-Narrow-Bold"
+ at map font 17 to "Helvetica-Narrow-BoldOblique", "Helvetica-Narrow-BoldOblique"
+ at map font 18 to "Helvetica-Narrow-Oblique", "Helvetica-Narrow-Oblique"
+ at map font 6 to "Helvetica-Oblique", "Helvetica-Oblique"
+ at map font 20 to "NewCenturySchlbk-Bold", "NewCenturySchlbk-Bold"
+ at map font 21 to "NewCenturySchlbk-BoldItalic", "NewCenturySchlbk-BoldItalic"
+ at map font 22 to "NewCenturySchlbk-Italic", "NewCenturySchlbk-Italic"
+ at map font 23 to "NewCenturySchlbk-Roman", "NewCenturySchlbk-Roman"
+ at map font 24 to "Palatino-Bold", "Palatino-Bold"
+ at map font 25 to "Palatino-BoldItalic", "Palatino-BoldItalic"
+ at map font 26 to "Palatino-Italic", "Palatino-Italic"
+ at map font 27 to "Palatino-Roman", "Palatino-Roman"
+ at map font 8 to "Symbol", "Symbol"
+ at map font 1 to "Times-Bold", "Times-Bold"
+ at map font 3 to "Times-BoldItalic", "Times-BoldItalic"
+ at map font 2 to "Times-Italic", "Times-Italic"
+ at map font 0 to "Times-Roman", "Times-Roman"
+ at map font 33 to "ZapfChancery-MediumItalic", "ZapfChancery-MediumItalic"
+ at map font 9 to "ZapfDingbats", "ZapfDingbats"
+ at map color 0 to (255, 255, 255), "white"
+ at map color 1 to (0, 0, 0), "black"
+ at map color 2 to (255, 0, 0), "red"
+ at map color 3 to (0, 255, 0), "green"
+ at map color 4 to (0, 0, 255), "blue"
+ at map color 5 to (255, 255, 0), "yellow"
+ at map color 6 to (188, 143, 143), "brown"
+ at map color 7 to (220, 220, 220), "grey"
+ at map color 8 to (148, 0, 211), "violet"
+ at map color 9 to (0, 255, 255), "cyan"
+ at map color 10 to (255, 0, 255), "magenta"
+ at map color 11 to (255, 165, 0), "orange"
+ at map color 12 to (114, 33, 188), "indigo"
+ at map color 13 to (103, 7, 72), "maroon"
+ at map color 14 to (64, 224, 208), "turquoise"
+ at map color 15 to (0, 139, 0), "green4"
+ at reference date 0
+ at date wrap on
+ at date wrap year 1900
+ at default linewidth 1.0
+ at default linestyle 1
+ at default color 1
+ at default pattern 1
+ at default font 4
+ at default char size 1.000000
+ at default symbol size 1.000000
+ at default sformat "%.8g"
+ at background color 0
+ at page background fill on
+ at timestamp off
+ at timestamp 0.03, 0.03
+ at timestamp color 1
+ at timestamp rot 0
+ at timestamp font 4
+ at timestamp char size 1.000000
+ at timestamp def "Thu May 26 18:00:35 2005"
+ at r0 off
+ at link r0 to g0
+ at r0 type above
+ at r0 linestyle 1
+ at r0 linewidth 1.0
+ at r0 color 1
+ at r0 line 0, 0, 0, 0
+ at r1 off
+ at link r1 to g0
+ at r1 type above
+ at r1 linestyle 1
+ at r1 linewidth 1.0
+ at r1 color 1
+ at r1 line 0, 0, 0, 0
+ at r2 off
+ at link r2 to g0
+ at r2 type above
+ at r2 linestyle 1
+ at r2 linewidth 1.0
+ at r2 color 1
+ at r2 line 0, 0, 0, 0
+ at r3 off
+ at link r3 to g0
+ at r3 type above
+ at r3 linestyle 1
+ at r3 linewidth 1.0
+ at r3 color 1
+ at r3 line 0, 0, 0, 0
+ at r4 off
+ at link r4 to g0
+ at r4 type above
+ at r4 linestyle 1
+ at r4 linewidth 1.0
+ at r4 color 1
+ at r4 line 0, 0, 0, 0
+ at g0 on
+ at g0 hidden false
+ at g0 type XY
+ at g0 stacked false
+ at g0 bar hgap 0.000000
+ at g0 fixedpoint off
+ at g0 fixedpoint type 0
+ at g0 fixedpoint xy 0.000000, 0.000000
+ at g0 fixedpoint format general general
+ at g0 fixedpoint prec 6, 6
+ at with g0
+@    world 3, 0.0001, 8, 1
+@    stack world 0, 0, 0, 0
+@    znorm 1
+@    view 0.129310, 0.100000, 0.614224, 0.475000
+@    title ""
+@    title font 4
+@    title size 1.500000
+@    title color 1
+@    subtitle ""
+@    subtitle font 4
+@    subtitle size 1.000000
+@    subtitle color 1
+@    xaxes scale Normal
+@    yaxes scale Logarithmic
+@    xaxes invert off
+@    yaxes invert off
+@    xaxis  on
+@    xaxis  type zero false
+@    xaxis  offset 0.000000 , 0.000000
+@    xaxis  bar off
+@    xaxis  bar color 1
+@    xaxis  bar linestyle 1
+@    xaxis  bar linewidth 1.0
+@    xaxis  label "Level"
+@    xaxis  label layout para
+@    xaxis  label place auto
+@    xaxis  label char size 0.600000
+@    xaxis  label font 4
+@    xaxis  label color 1
+@    xaxis  label place normal
+@    xaxis  tick on
+@    xaxis  tick major 1
+@    xaxis  tick minor ticks 1
+@    xaxis  tick default 6
+@    xaxis  tick place rounded true
+@    xaxis  tick in
+@    xaxis  tick major size 1.000000
+@    xaxis  tick major color 1
+@    xaxis  tick major linewidth 1.0
+@    xaxis  tick major linestyle 1
+@    xaxis  tick major grid off
+@    xaxis  tick minor color 1
+@    xaxis  tick minor linewidth 1.0
+@    xaxis  tick minor linestyle 1
+@    xaxis  tick minor grid off
+@    xaxis  tick minor size 0.500000
+@    xaxis  ticklabel on
+@    xaxis  ticklabel format general
+@    xaxis  ticklabel prec 5
+@    xaxis  ticklabel formula ""
+@    xaxis  ticklabel append ""
+@    xaxis  ticklabel prepend ""
+@    xaxis  ticklabel angle 0
+@    xaxis  ticklabel skip 0
+@    xaxis  ticklabel stagger 0
+@    xaxis  ticklabel place normal
+@    xaxis  ticklabel offset auto
+@    xaxis  ticklabel offset 0.000000 , 0.010000
+@    xaxis  ticklabel start type auto
+@    xaxis  ticklabel start 0.000000
+@    xaxis  ticklabel stop type auto
+@    xaxis  ticklabel stop 0.000000
+@    xaxis  ticklabel char size 0.600000
+@    xaxis  ticklabel font 4
+@    xaxis  ticklabel color 1
+@    xaxis  tick place both
+@    xaxis  tick spec type none
+@    yaxis  on
+@    yaxis  type zero false
+@    yaxis  offset 0.000000 , 0.000000
+@    yaxis  bar off
+@    yaxis  bar color 1
+@    yaxis  bar linestyle 1
+@    yaxis  bar linewidth 1.0
+@    yaxis  label "Error"
+@    yaxis  label layout para
+@    yaxis  label place auto
+@    yaxis  label char size 0.600000
+@    yaxis  label font 4
+@    yaxis  label color 1
+@    yaxis  label place normal
+@    yaxis  tick on
+@    yaxis  tick major 10
+@    yaxis  tick minor ticks 0
+@    yaxis  tick default 6
+@    yaxis  tick place rounded true
+@    yaxis  tick in
+@    yaxis  tick major size 1.000000
+@    yaxis  tick major color 1
+@    yaxis  tick major linewidth 1.0
+@    yaxis  tick major linestyle 3
+@    yaxis  tick major grid on
+@    yaxis  tick minor color 1
+@    yaxis  tick minor linewidth 1.0
+@    yaxis  tick minor linestyle 1
+@    yaxis  tick minor grid off
+@    yaxis  tick minor size 0.500000
+@    yaxis  ticklabel on
+@    yaxis  ticklabel format general
+@    yaxis  ticklabel prec 0
+@    yaxis  ticklabel formula ""
+@    yaxis  ticklabel append ""
+@    yaxis  ticklabel prepend ""
+@    yaxis  ticklabel angle 0
+@    yaxis  ticklabel skip 0
+@    yaxis  ticklabel stagger 0
+@    yaxis  ticklabel place normal
+@    yaxis  ticklabel offset auto
+@    yaxis  ticklabel offset 0.000000 , 0.010000
+@    yaxis  ticklabel start type auto
+@    yaxis  ticklabel start 0.000000
+@    yaxis  ticklabel stop type auto
+@    yaxis  ticklabel stop 0.000000
+@    yaxis  ticklabel char size 0.600000
+@    yaxis  ticklabel font 4
+@    yaxis  ticklabel color 1
+@    yaxis  tick place both
+@    yaxis  tick spec type none
+@    altxaxis  off
+@    altyaxis  off
+@    legend on
+@    legend loctype view
+@    legend 0.181034482759, 0.25
+@    legend box color 1
+@    legend box pattern 0
+@    legend box linewidth 1.0
+@    legend box linestyle 1
+@    legend box fill color 0
+@    legend box fill pattern 1
+@    legend font 4
+@    legend char size 0.460000
+@    legend color 1
+@    legend length 4
+@    legend vgap 1
+@    legend hgap 1
+@    legend invert false
+@    frame type 0
+@    frame linestyle 1
+@    frame linewidth 1.0
+@    frame color 1
+@    frame pattern 1
+@    frame background color 0
+@    frame background pattern 0
+@    s0 hidden false
+@    s0 type xy
+@    s0 symbol 1
+@    s0 symbol size 0.340000
+@    s0 symbol color 1
+@    s0 symbol pattern 1
+@    s0 symbol fill color 1
+@    s0 symbol fill pattern 1
+@    s0 symbol linewidth 1.0
+@    s0 symbol linestyle 1
+@    s0 symbol char 0
+@    s0 symbol char font 4
+@    s0 symbol skip 0
+@    s0 line type 1
+@    s0 line linestyle 1
+@    s0 line linewidth 1.0
+@    s0 line color 1
+@    s0 line pattern 1
+@    s0 baseline type 0
+@    s0 baseline off
+@    s0 dropline off
+@    s0 fill type 0
+@    s0 fill rule 0
+@    s0 fill color 1
+@    s0 fill pattern 1
+@    s0 avalue off
+@    s0 avalue type 2
+@    s0 avalue char size 1.000000
+@    s0 avalue font 4
+@    s0 avalue color 1
+@    s0 avalue rot 0
+@    s0 avalue format general
+@    s0 avalue prec 3
+@    s0 avalue prepend ""
+@    s0 avalue append ""
+@    s0 avalue offset 0.000000 , 0.000000
+@    s0 errorbar on
+@    s0 errorbar place both
+@    s0 errorbar color 1
+@    s0 errorbar pattern 1
+@    s0 errorbar size 2.000000
+@    s0 errorbar linewidth 1.0
+@    s0 errorbar linestyle 1
+@    s0 errorbar riser linewidth 1.0
+@    s0 errorbar riser linestyle 1
+@    s0 errorbar riser clip off
+@    s0 errorbar riser clip length 0.100000
+@    s0 comment "/tmp/toto"
+@    s0 legend  "first"
+@    s1 hidden false
+@    s1 type xy
+@    s1 symbol 2
+@    s1 symbol size 0.440000
+@    s1 symbol color 1
+@    s1 symbol pattern 1
+@    s1 symbol fill color 1
+@    s1 symbol fill pattern 1
+@    s1 symbol linewidth 1.0
+@    s1 symbol linestyle 1
+@    s1 symbol char 0
+@    s1 symbol char font 4
+@    s1 symbol skip 0
+@    s1 line type 1
+@    s1 line linestyle 1
+@    s1 line linewidth 1.0
+@    s1 line color 1
+@    s1 line pattern 1
+@    s1 baseline type 0
+@    s1 baseline off
+@    s1 dropline off
+@    s1 fill type 0
+@    s1 fill rule 0
+@    s1 fill color 1
+@    s1 fill pattern 1
+@    s1 avalue off
+@    s1 avalue type 2
+@    s1 avalue char size 1.000000
+@    s1 avalue font 4
+@    s1 avalue color 1
+@    s1 avalue rot 0
+@    s1 avalue format general
+@    s1 avalue prec 3
+@    s1 avalue prepend ""
+@    s1 avalue append ""
+@    s1 avalue offset 0.000000 , 0.000000
+@    s1 errorbar on
+@    s1 errorbar place both
+@    s1 errorbar color 1
+@    s1 errorbar pattern 1
+@    s1 errorbar size 2.000000
+@    s1 errorbar linewidth 1.0
+@    s1 errorbar linestyle 1
+@    s1 errorbar riser linewidth 1.0
+@    s1 errorbar riser linestyle 1
+@    s1 errorbar riser clip off
+@    s1 errorbar riser clip length 0.100000
+@    s1 comment "/tmp/toto"
+@    s1 legend  "second"
+@    s2 hidden false
+@    s2 type xy
+@    s2 symbol 4
+@    s2 symbol size 0.340000
+@    s2 symbol color 1
+@    s2 symbol pattern 1
+@    s2 symbol fill color 1
+@    s2 symbol fill pattern 1
+@    s2 symbol linewidth 1.0
+@    s2 symbol linestyle 1
+@    s2 symbol char 0
+@    s2 symbol char font 4
+@    s2 symbol skip 0
+@    s2 line type 1
+@    s2 line linestyle 1
+@    s2 line linewidth 1.0
+@    s2 line color 1
+@    s2 line pattern 1
+@    s2 baseline type 0
+@    s2 baseline off
+@    s2 dropline off
+@    s2 fill type 0
+@    s2 fill rule 0
+@    s2 fill color 1
+@    s2 fill pattern 1
+@    s2 avalue off
+@    s2 avalue type 2
+@    s2 avalue char size 1.000000
+@    s2 avalue font 4
+@    s2 avalue color 1
+@    s2 avalue rot 0
+@    s2 avalue format general
+@    s2 avalue prec 3
+@    s2 avalue prepend ""
+@    s2 avalue append ""
+@    s2 avalue offset 0.000000 , 0.000000
+@    s2 errorbar on
+@    s2 errorbar place both
+@    s2 errorbar color 1
+@    s2 errorbar pattern 1
+@    s2 errorbar size 2.000000
+@    s2 errorbar linewidth 1.0
+@    s2 errorbar linestyle 1
+@    s2 errorbar riser linewidth 1.0
+@    s2 errorbar riser linestyle 1
+@    s2 errorbar riser clip off
+@    s2 errorbar riser clip length 0.100000
+@    s2 comment "/tmp/toto"
+@    s2 legend  "infinite"
+ at g1 on
+ at g1 hidden false
+ at g1 type XY
+ at g1 stacked false
+ at g1 bar hgap 0.000000
+ at g1 fixedpoint off
+ at g1 fixedpoint type 0
+ at g1 fixedpoint xy 0.000000, 0.000000
+ at g1 fixedpoint format general general
+ at g1 fixedpoint prec 6, 6
+ at with g1
+@    world 4, -1, 8, 2.5
+@    stack world 0, 0, 0, 0
+@    znorm 1
+@    view 0.129310, 0.575000, 0.614224, 0.950000
+@    title ""
+@    title font 4
+@    title size 1.500000
+@    title color 1
+@    subtitle ""
+@    subtitle font 4
+@    subtitle size 1.000000
+@    subtitle color 1
+@    xaxes scale Normal
+@    yaxes scale Normal
+@    xaxes invert off
+@    yaxes invert off
+@    xaxis  on
+@    xaxis  type zero false
+@    xaxis  offset 0.000000 , 0.000000
+@    xaxis  bar off
+@    xaxis  bar color 1
+@    xaxis  bar linestyle 1
+@    xaxis  bar linewidth 1.0
+@    xaxis  label "Level"
+@    xaxis  label layout para
+@    xaxis  label place auto
+@    xaxis  label char size 0.600000
+@    xaxis  label font 4
+@    xaxis  label color 1
+@    xaxis  label place normal
+@    xaxis  tick on
+@    xaxis  tick major 1
+@    xaxis  tick minor ticks 1
+@    xaxis  tick default 6
+@    xaxis  tick place rounded true
+@    xaxis  tick in
+@    xaxis  tick major size 1.000000
+@    xaxis  tick major color 1
+@    xaxis  tick major linewidth 1.0
+@    xaxis  tick major linestyle 1
+@    xaxis  tick major grid off
+@    xaxis  tick minor color 1
+@    xaxis  tick minor linewidth 1.0
+@    xaxis  tick minor linestyle 1
+@    xaxis  tick minor grid off
+@    xaxis  tick minor size 0.500000
+@    xaxis  ticklabel on
+@    xaxis  ticklabel format general
+@    xaxis  ticklabel prec 5
+@    xaxis  ticklabel formula ""
+@    xaxis  ticklabel append ""
+@    xaxis  ticklabel prepend ""
+@    xaxis  ticklabel angle 0
+@    xaxis  ticklabel skip 0
+@    xaxis  ticklabel stagger 0
+@    xaxis  ticklabel place normal
+@    xaxis  ticklabel offset auto
+@    xaxis  ticklabel offset 0.000000 , 0.010000
+@    xaxis  ticklabel start type auto
+@    xaxis  ticklabel start 0.000000
+@    xaxis  ticklabel stop type auto
+@    xaxis  ticklabel stop 0.000000
+@    xaxis  ticklabel char size 0.600000
+@    xaxis  ticklabel font 4
+@    xaxis  ticklabel color 1
+@    xaxis  tick place both
+@    xaxis  tick spec type none
+@    yaxis  on
+@    yaxis  type zero false
+@    yaxis  offset 0.000000 , 0.000000
+@    yaxis  bar off
+@    yaxis  bar color 1
+@    yaxis  bar linestyle 1
+@    yaxis  bar linewidth 1.0
+@    yaxis  label "Order"
+@    yaxis  label layout para
+@    yaxis  label place auto
+@    yaxis  label char size 0.600000
+@    yaxis  label font 4
+@    yaxis  label color 1
+@    yaxis  label place normal
+@    yaxis  tick on
+@    yaxis  tick major 0.5
+@    yaxis  tick minor ticks 1
+@    yaxis  tick default 6
+@    yaxis  tick place rounded true
+@    yaxis  tick in
+@    yaxis  tick major size 1.000000
+@    yaxis  tick major color 1
+@    yaxis  tick major linewidth 1.0
+@    yaxis  tick major linestyle 3
+@    yaxis  tick major grid off
+@    yaxis  tick minor color 1
+@    yaxis  tick minor linewidth 1.0
+@    yaxis  tick minor linestyle 1
+@    yaxis  tick minor grid off
+@    yaxis  tick minor size 0.500000
+@    yaxis  ticklabel on
+@    yaxis  ticklabel format general
+@    yaxis  ticklabel prec 5
+@    yaxis  ticklabel formula ""
+@    yaxis  ticklabel append ""
+@    yaxis  ticklabel prepend ""
+@    yaxis  ticklabel angle 0
+@    yaxis  ticklabel skip 0
+@    yaxis  ticklabel stagger 0
+@    yaxis  ticklabel place normal
+@    yaxis  ticklabel offset auto
+@    yaxis  ticklabel offset 0.000000 , 0.010000
+@    yaxis  ticklabel start type auto
+@    yaxis  ticklabel start 0.000000
+@    yaxis  ticklabel stop type auto
+@    yaxis  ticklabel stop 0.000000
+@    yaxis  ticklabel char size 0.600000
+@    yaxis  ticklabel font 4
+@    yaxis  ticklabel color 1
+@    yaxis  tick place both
+@    yaxis  tick spec type none
+@    altxaxis  off
+@    altyaxis  off
+@    legend on
+@    legend loctype view
+@    legend 0.4, 0.75
+@    legend box color 1
+@    legend box pattern 0
+@    legend box linewidth 1.0
+@    legend box linestyle 1
+@    legend box fill color 0
+@    legend box fill pattern 1
+@    legend font 4
+@    legend char size 0.460000
+@    legend color 1
+@    legend length 4
+@    legend vgap 1
+@    legend hgap 1
+@    legend invert false
+@    frame type 0
+@    frame linestyle 1
+@    frame linewidth 1.0
+@    frame color 1
+@    frame pattern 1
+@    frame background color 0
+@    frame background pattern 0
+@    s0 hidden false
+@    s0 type xy
+@    s0 symbol 1
+@    s0 symbol size 0.340000
+@    s0 symbol color 1
+@    s0 symbol pattern 1
+@    s0 symbol fill color 1
+@    s0 symbol fill pattern 1
+@    s0 symbol linewidth 1.0
+@    s0 symbol linestyle 1
+@    s0 symbol char 0
+@    s0 symbol char font 4
+@    s0 symbol skip 0
+@    s0 line type 1
+@    s0 line linestyle 1
+@    s0 line linewidth 1.0
+@    s0 line color 1
+@    s0 line pattern 1
+@    s0 baseline type 0
+@    s0 baseline off
+@    s0 dropline off
+@    s0 fill type 0
+@    s0 fill rule 0
+@    s0 fill color 1
+@    s0 fill pattern 1
+@    s0 avalue off
+@    s0 avalue type 2
+@    s0 avalue char size 1.000000
+@    s0 avalue font 4
+@    s0 avalue color 1
+@    s0 avalue rot 0
+@    s0 avalue format general
+@    s0 avalue prec 3
+@    s0 avalue prepend ""
+@    s0 avalue append ""
+@    s0 avalue offset 0.000000 , 0.000000
+@    s0 errorbar on
+@    s0 errorbar place both
+@    s0 errorbar color 1
+@    s0 errorbar pattern 1
+@    s0 errorbar size 2.000000
+@    s0 errorbar linewidth 1.0
+@    s0 errorbar linestyle 1
+@    s0 errorbar riser linewidth 1.0
+@    s0 errorbar riser linestyle 1
+@    s0 errorbar riser clip off
+@    s0 errorbar riser clip length 0.100000
+@    s0 comment "/tmp/toto"
+@    s0 legend  "first"
+@    s1 hidden false
+@    s1 type xy
+@    s1 symbol 2
+@    s1 symbol size 0.440000
+@    s1 symbol color 1
+@    s1 symbol pattern 1
+@    s1 symbol fill color 1
+@    s1 symbol fill pattern 1
+@    s1 symbol linewidth 1.0
+@    s1 symbol linestyle 1
+@    s1 symbol char 0
+@    s1 symbol char font 4
+@    s1 symbol skip 0
+@    s1 line type 1
+@    s1 line linestyle 1
+@    s1 line linewidth 1.0
+@    s1 line color 1
+@    s1 line pattern 1
+@    s1 baseline type 0
+@    s1 baseline off
+@    s1 dropline off
+@    s1 fill type 0
+@    s1 fill rule 0
+@    s1 fill color 1
+@    s1 fill pattern 1
+@    s1 avalue off
+@    s1 avalue type 2
+@    s1 avalue char size 1.000000
+@    s1 avalue font 4
+@    s1 avalue color 1
+@    s1 avalue rot 0
+@    s1 avalue format general
+@    s1 avalue prec 3
+@    s1 avalue prepend ""
+@    s1 avalue append ""
+@    s1 avalue offset 0.000000 , 0.000000
+@    s1 errorbar on
+@    s1 errorbar place both
+@    s1 errorbar color 1
+@    s1 errorbar pattern 1
+@    s1 errorbar size 2.000000
+@    s1 errorbar linewidth 1.0
+@    s1 errorbar linestyle 1
+@    s1 errorbar riser linewidth 1.0
+@    s1 errorbar riser linestyle 1
+@    s1 errorbar riser clip off
+@    s1 errorbar riser clip length 0.100000
+@    s1 comment "/tmp/toto"
+@    s1 legend  "second"
+@    s2 hidden false
+@    s2 type xy
+@    s2 symbol 4
+@    s2 symbol size 0.340000
+@    s2 symbol color 1
+@    s2 symbol pattern 1
+@    s2 symbol fill color 1
+@    s2 symbol fill pattern 1
+@    s2 symbol linewidth 1.0
+@    s2 symbol linestyle 1
+@    s2 symbol char 0
+@    s2 symbol char font 4
+@    s2 symbol skip 0
+@    s2 line type 1
+@    s2 line linestyle 1
+@    s2 line linewidth 1.0
+@    s2 line color 1
+@    s2 line pattern 1
+@    s2 baseline type 0
+@    s2 baseline off
+@    s2 dropline off
+@    s2 fill type 0
+@    s2 fill rule 0
+@    s2 fill color 1
+@    s2 fill pattern 1
+@    s2 avalue off
+@    s2 avalue type 2
+@    s2 avalue char size 1.000000
+@    s2 avalue font 4
+@    s2 avalue color 1
+@    s2 avalue rot 0
+@    s2 avalue format general
+@    s2 avalue prec 3
+@    s2 avalue prepend ""
+@    s2 avalue append ""
+@    s2 avalue offset 0.000000 , 0.000000
+@    s2 errorbar on
+@    s2 errorbar place both
+@    s2 errorbar color 1
+@    s2 errorbar pattern 1
+@    s2 errorbar size 2.000000
+@    s2 errorbar linewidth 1.0
+@    s2 errorbar linestyle 1
+@    s2 errorbar riser linewidth 1.0
+@    s2 errorbar riser linestyle 1
+@    s2 errorbar riser clip off
+@    s2 errorbar riser clip length 0.100000
+@    s2 comment "/tmp/toto"
+@    s2 legend  "infinite"
+ at target G0.S0
+ at type xy
+3 4.624e-02
+4 3.638e-02
+5 3.577e-02
+6 1.553e-02
+7 4.201e-03
+8 1.057e-03
+ at target G0.S1
+ at type xy
+3 6.661e-02
+4 7.357e-02
+5 6.878e-02
+6 3.104e-02
+7 8.430e-03
+8 2.122e-03
+ at target G0.S2
+ at type xy
+3 2.328e-01
+4 3.899e-01
+5 4.140e-01
+6 1.790e-01
+7 4.760e-02
+8 1.183e-02
+ at target G1.S0
+ at type xy
+4 0.345996
+5 0.0243954
+6 1.20369
+7 1.88625
+8 1.99076
+ at target G1.S1
+ at type xy
+4 -0.143379
+5 0.0971285
+6 1.14786
+7 1.88052
+8 1.99011
+ at target G1.S2
+ at type xy
+4 -0.744013
+5 -0.0865266
+6 1.20967
+7 1.91093
+8 2.00851
diff --git a/test/advection/order/tests/translate3/advection.gfs b/test/advection/order/tests/translate3/advection.gfs
new file mode 100644
index 0000000..3eb89b4
--- /dev/null
+++ b/test/advection/order/tests/translate3/advection.gfs
@@ -0,0 +1,19 @@
+1 2 GfsAdvection GfsBox GfsGEdge {} {
+  Time { end = 2.236067 }
+  Refine LEVEL
+  VariableTracer {} T {
+    gradient = gfs_center_gradient
+  }
+  AdvectionParams { cfl = 0.5 }
+  Init {} {
+    U = { double theta = atan (1./2.); return cos (theta); }
+    V = { double theta = atan (1./2.); return sin (theta); }
+    T = { return (1. + cos(2.*M_PI*x)*sin(2.*M_PI*y))/2.; }
+  }
+  OutputErrorNorm { start = end } { awk '{ print LEVEL " " $5 " " $7 " " $9}' } { v = T } {
+    s = { return (1. + cos(2.*M_PI*x)*sin(2.*M_PI*y))/2.; }
+  }
+}
+GfsBox {}
+1 1 right
+1 1 top
diff --git a/test/advection/order/tests/translate3/description.tex b/test/advection/order/tests/translate3/description.tex
new file mode 100644
index 0000000..704c79e
--- /dev/null
+++ b/test/advection/order/tests/translate3/description.tex
@@ -0,0 +1 @@
+Translation of a smooth field (``periodic''), periodic boundary conditions, no limiter, CFL of 0.5.
diff --git a/test/advection/order/tests/translate3/reference.xmgr b/test/advection/order/tests/translate3/reference.xmgr
new file mode 100644
index 0000000..d44e6ad
--- /dev/null
+++ b/test/advection/order/tests/translate3/reference.xmgr
@@ -0,0 +1,751 @@
+# Grace project file
+#
+ at version 50118
+ at page size 792, 612
+ at description "advection -n -S -t -p"
+ at page scroll 5%
+ at page inout 5%
+ at link page off
+ at map font 10 to "Courier-BoldOblique", "Courier-BoldOblique"
+ at map font 11 to "Courier-Oblique", "Courier-Oblique"
+ at map font 4 to "Helvetica", "Helvetica"
+ at map font 5 to "Helvetica-Bold", "Helvetica-Bold"
+ at map font 7 to "Helvetica-BoldOblique", "Helvetica-BoldOblique"
+ at map font 15 to "Helvetica-Narrow", "Helvetica-Narrow"
+ at map font 16 to "Helvetica-Narrow-Bold", "Helvetica-Narrow-Bold"
+ at map font 17 to "Helvetica-Narrow-BoldOblique", "Helvetica-Narrow-BoldOblique"
+ at map font 18 to "Helvetica-Narrow-Oblique", "Helvetica-Narrow-Oblique"
+ at map font 6 to "Helvetica-Oblique", "Helvetica-Oblique"
+ at map font 20 to "NewCenturySchlbk-Bold", "NewCenturySchlbk-Bold"
+ at map font 21 to "NewCenturySchlbk-BoldItalic", "NewCenturySchlbk-BoldItalic"
+ at map font 22 to "NewCenturySchlbk-Italic", "NewCenturySchlbk-Italic"
+ at map font 23 to "NewCenturySchlbk-Roman", "NewCenturySchlbk-Roman"
+ at map font 24 to "Palatino-Bold", "Palatino-Bold"
+ at map font 25 to "Palatino-BoldItalic", "Palatino-BoldItalic"
+ at map font 26 to "Palatino-Italic", "Palatino-Italic"
+ at map font 27 to "Palatino-Roman", "Palatino-Roman"
+ at map font 8 to "Symbol", "Symbol"
+ at map font 1 to "Times-Bold", "Times-Bold"
+ at map font 3 to "Times-BoldItalic", "Times-BoldItalic"
+ at map font 2 to "Times-Italic", "Times-Italic"
+ at map font 0 to "Times-Roman", "Times-Roman"
+ at map font 33 to "ZapfChancery-MediumItalic", "ZapfChancery-MediumItalic"
+ at map font 9 to "ZapfDingbats", "ZapfDingbats"
+ at map color 0 to (255, 255, 255), "white"
+ at map color 1 to (0, 0, 0), "black"
+ at map color 2 to (255, 0, 0), "red"
+ at map color 3 to (0, 255, 0), "green"
+ at map color 4 to (0, 0, 255), "blue"
+ at map color 5 to (255, 255, 0), "yellow"
+ at map color 6 to (188, 143, 143), "brown"
+ at map color 7 to (220, 220, 220), "grey"
+ at map color 8 to (148, 0, 211), "violet"
+ at map color 9 to (0, 255, 255), "cyan"
+ at map color 10 to (255, 0, 255), "magenta"
+ at map color 11 to (255, 165, 0), "orange"
+ at map color 12 to (114, 33, 188), "indigo"
+ at map color 13 to (103, 7, 72), "maroon"
+ at map color 14 to (64, 224, 208), "turquoise"
+ at map color 15 to (0, 139, 0), "green4"
+ at reference date 0
+ at date wrap on
+ at date wrap year 1900
+ at default linewidth 1.0
+ at default linestyle 1
+ at default color 1
+ at default pattern 1
+ at default font 4
+ at default char size 1.000000
+ at default symbol size 1.000000
+ at default sformat "%.8g"
+ at background color 0
+ at page background fill on
+ at timestamp off
+ at timestamp 0.03, 0.03
+ at timestamp color 1
+ at timestamp rot 0
+ at timestamp font 4
+ at timestamp char size 1.000000
+ at timestamp def "Thu May 26 18:01:57 2005"
+ at r0 off
+ at link r0 to g0
+ at r0 type above
+ at r0 linestyle 1
+ at r0 linewidth 1.0
+ at r0 color 1
+ at r0 line 0, 0, 0, 0
+ at r1 off
+ at link r1 to g0
+ at r1 type above
+ at r1 linestyle 1
+ at r1 linewidth 1.0
+ at r1 color 1
+ at r1 line 0, 0, 0, 0
+ at r2 off
+ at link r2 to g0
+ at r2 type above
+ at r2 linestyle 1
+ at r2 linewidth 1.0
+ at r2 color 1
+ at r2 line 0, 0, 0, 0
+ at r3 off
+ at link r3 to g0
+ at r3 type above
+ at r3 linestyle 1
+ at r3 linewidth 1.0
+ at r3 color 1
+ at r3 line 0, 0, 0, 0
+ at r4 off
+ at link r4 to g0
+ at r4 type above
+ at r4 linestyle 1
+ at r4 linewidth 1.0
+ at r4 color 1
+ at r4 line 0, 0, 0, 0
+ at g0 on
+ at g0 hidden false
+ at g0 type XY
+ at g0 stacked false
+ at g0 bar hgap 0.000000
+ at g0 fixedpoint off
+ at g0 fixedpoint type 0
+ at g0 fixedpoint xy 0.000000, 0.000000
+ at g0 fixedpoint format general general
+ at g0 fixedpoint prec 6, 6
+ at with g0
+@    world 3, 1e-05, 8, 1
+@    stack world 0, 0, 0, 0
+@    znorm 1
+@    view 0.129310, 0.100000, 0.614224, 0.475000
+@    title ""
+@    title font 4
+@    title size 1.500000
+@    title color 1
+@    subtitle ""
+@    subtitle font 4
+@    subtitle size 1.000000
+@    subtitle color 1
+@    xaxes scale Normal
+@    yaxes scale Logarithmic
+@    xaxes invert off
+@    yaxes invert off
+@    xaxis  on
+@    xaxis  type zero false
+@    xaxis  offset 0.000000 , 0.000000
+@    xaxis  bar off
+@    xaxis  bar color 1
+@    xaxis  bar linestyle 1
+@    xaxis  bar linewidth 1.0
+@    xaxis  label "Level"
+@    xaxis  label layout para
+@    xaxis  label place auto
+@    xaxis  label char size 0.600000
+@    xaxis  label font 4
+@    xaxis  label color 1
+@    xaxis  label place normal
+@    xaxis  tick on
+@    xaxis  tick major 1
+@    xaxis  tick minor ticks 1
+@    xaxis  tick default 6
+@    xaxis  tick place rounded true
+@    xaxis  tick in
+@    xaxis  tick major size 1.000000
+@    xaxis  tick major color 1
+@    xaxis  tick major linewidth 1.0
+@    xaxis  tick major linestyle 1
+@    xaxis  tick major grid off
+@    xaxis  tick minor color 1
+@    xaxis  tick minor linewidth 1.0
+@    xaxis  tick minor linestyle 1
+@    xaxis  tick minor grid off
+@    xaxis  tick minor size 0.500000
+@    xaxis  ticklabel on
+@    xaxis  ticklabel format general
+@    xaxis  ticklabel prec 5
+@    xaxis  ticklabel formula ""
+@    xaxis  ticklabel append ""
+@    xaxis  ticklabel prepend ""
+@    xaxis  ticklabel angle 0
+@    xaxis  ticklabel skip 0
+@    xaxis  ticklabel stagger 0
+@    xaxis  ticklabel place normal
+@    xaxis  ticklabel offset auto
+@    xaxis  ticklabel offset 0.000000 , 0.010000
+@    xaxis  ticklabel start type auto
+@    xaxis  ticklabel start 0.000000
+@    xaxis  ticklabel stop type auto
+@    xaxis  ticklabel stop 0.000000
+@    xaxis  ticklabel char size 0.600000
+@    xaxis  ticklabel font 4
+@    xaxis  ticklabel color 1
+@    xaxis  tick place both
+@    xaxis  tick spec type none
+@    yaxis  on
+@    yaxis  type zero false
+@    yaxis  offset 0.000000 , 0.000000
+@    yaxis  bar off
+@    yaxis  bar color 1
+@    yaxis  bar linestyle 1
+@    yaxis  bar linewidth 1.0
+@    yaxis  label "Error"
+@    yaxis  label layout para
+@    yaxis  label place auto
+@    yaxis  label char size 0.600000
+@    yaxis  label font 4
+@    yaxis  label color 1
+@    yaxis  label place normal
+@    yaxis  tick on
+@    yaxis  tick major 10
+@    yaxis  tick minor ticks 0
+@    yaxis  tick default 6
+@    yaxis  tick place rounded true
+@    yaxis  tick in
+@    yaxis  tick major size 1.000000
+@    yaxis  tick major color 1
+@    yaxis  tick major linewidth 1.0
+@    yaxis  tick major linestyle 3
+@    yaxis  tick major grid on
+@    yaxis  tick minor color 1
+@    yaxis  tick minor linewidth 1.0
+@    yaxis  tick minor linestyle 1
+@    yaxis  tick minor grid off
+@    yaxis  tick minor size 0.500000
+@    yaxis  ticklabel on
+@    yaxis  ticklabel format general
+@    yaxis  ticklabel prec 0
+@    yaxis  ticklabel formula ""
+@    yaxis  ticklabel append ""
+@    yaxis  ticklabel prepend ""
+@    yaxis  ticklabel angle 0
+@    yaxis  ticklabel skip 0
+@    yaxis  ticklabel stagger 0
+@    yaxis  ticklabel place normal
+@    yaxis  ticklabel offset auto
+@    yaxis  ticklabel offset 0.000000 , 0.010000
+@    yaxis  ticklabel start type auto
+@    yaxis  ticklabel start 0.000000
+@    yaxis  ticklabel stop type auto
+@    yaxis  ticklabel stop 0.000000
+@    yaxis  ticklabel char size 0.590000
+@    yaxis  ticklabel font 4
+@    yaxis  ticklabel color 1
+@    yaxis  tick place both
+@    yaxis  tick spec type none
+@    altxaxis  off
+@    altyaxis  off
+@    legend on
+@    legend loctype view
+@    legend 0.181034482759, 0.25
+@    legend box color 1
+@    legend box pattern 0
+@    legend box linewidth 1.0
+@    legend box linestyle 1
+@    legend box fill color 0
+@    legend box fill pattern 1
+@    legend font 4
+@    legend char size 0.460000
+@    legend color 1
+@    legend length 4
+@    legend vgap 1
+@    legend hgap 1
+@    legend invert false
+@    frame type 0
+@    frame linestyle 1
+@    frame linewidth 1.0
+@    frame color 1
+@    frame pattern 1
+@    frame background color 0
+@    frame background pattern 0
+@    s0 hidden false
+@    s0 type xy
+@    s0 symbol 1
+@    s0 symbol size 0.340000
+@    s0 symbol color 1
+@    s0 symbol pattern 1
+@    s0 symbol fill color 1
+@    s0 symbol fill pattern 1
+@    s0 symbol linewidth 1.0
+@    s0 symbol linestyle 1
+@    s0 symbol char 0
+@    s0 symbol char font 4
+@    s0 symbol skip 0
+@    s0 line type 1
+@    s0 line linestyle 1
+@    s0 line linewidth 1.0
+@    s0 line color 1
+@    s0 line pattern 1
+@    s0 baseline type 0
+@    s0 baseline off
+@    s0 dropline off
+@    s0 fill type 0
+@    s0 fill rule 0
+@    s0 fill color 1
+@    s0 fill pattern 1
+@    s0 avalue off
+@    s0 avalue type 2
+@    s0 avalue char size 1.000000
+@    s0 avalue font 4
+@    s0 avalue color 1
+@    s0 avalue rot 0
+@    s0 avalue format general
+@    s0 avalue prec 3
+@    s0 avalue prepend ""
+@    s0 avalue append ""
+@    s0 avalue offset 0.000000 , 0.000000
+@    s0 errorbar on
+@    s0 errorbar place both
+@    s0 errorbar color 1
+@    s0 errorbar pattern 1
+@    s0 errorbar size 2.000000
+@    s0 errorbar linewidth 1.0
+@    s0 errorbar linestyle 1
+@    s0 errorbar riser linewidth 1.0
+@    s0 errorbar riser linestyle 1
+@    s0 errorbar riser clip off
+@    s0 errorbar riser clip length 0.100000
+@    s0 comment "/tmp/toto"
+@    s0 legend  "first"
+@    s1 hidden false
+@    s1 type xy
+@    s1 symbol 2
+@    s1 symbol size 0.440000
+@    s1 symbol color 1
+@    s1 symbol pattern 1
+@    s1 symbol fill color 1
+@    s1 symbol fill pattern 1
+@    s1 symbol linewidth 1.0
+@    s1 symbol linestyle 1
+@    s1 symbol char 0
+@    s1 symbol char font 4
+@    s1 symbol skip 0
+@    s1 line type 1
+@    s1 line linestyle 1
+@    s1 line linewidth 1.0
+@    s1 line color 1
+@    s1 line pattern 1
+@    s1 baseline type 0
+@    s1 baseline off
+@    s1 dropline off
+@    s1 fill type 0
+@    s1 fill rule 0
+@    s1 fill color 1
+@    s1 fill pattern 1
+@    s1 avalue off
+@    s1 avalue type 2
+@    s1 avalue char size 1.000000
+@    s1 avalue font 4
+@    s1 avalue color 1
+@    s1 avalue rot 0
+@    s1 avalue format general
+@    s1 avalue prec 3
+@    s1 avalue prepend ""
+@    s1 avalue append ""
+@    s1 avalue offset 0.000000 , 0.000000
+@    s1 errorbar on
+@    s1 errorbar place both
+@    s1 errorbar color 1
+@    s1 errorbar pattern 1
+@    s1 errorbar size 2.000000
+@    s1 errorbar linewidth 1.0
+@    s1 errorbar linestyle 1
+@    s1 errorbar riser linewidth 1.0
+@    s1 errorbar riser linestyle 1
+@    s1 errorbar riser clip off
+@    s1 errorbar riser clip length 0.100000
+@    s1 comment "/tmp/toto"
+@    s1 legend  "second"
+@    s2 hidden false
+@    s2 type xy
+@    s2 symbol 4
+@    s2 symbol size 0.340000
+@    s2 symbol color 1
+@    s2 symbol pattern 1
+@    s2 symbol fill color 1
+@    s2 symbol fill pattern 1
+@    s2 symbol linewidth 1.0
+@    s2 symbol linestyle 1
+@    s2 symbol char 0
+@    s2 symbol char font 4
+@    s2 symbol skip 0
+@    s2 line type 1
+@    s2 line linestyle 1
+@    s2 line linewidth 1.0
+@    s2 line color 1
+@    s2 line pattern 1
+@    s2 baseline type 0
+@    s2 baseline off
+@    s2 dropline off
+@    s2 fill type 0
+@    s2 fill rule 0
+@    s2 fill color 1
+@    s2 fill pattern 1
+@    s2 avalue off
+@    s2 avalue type 2
+@    s2 avalue char size 1.000000
+@    s2 avalue font 4
+@    s2 avalue color 1
+@    s2 avalue rot 0
+@    s2 avalue format general
+@    s2 avalue prec 3
+@    s2 avalue prepend ""
+@    s2 avalue append ""
+@    s2 avalue offset 0.000000 , 0.000000
+@    s2 errorbar on
+@    s2 errorbar place both
+@    s2 errorbar color 1
+@    s2 errorbar pattern 1
+@    s2 errorbar size 2.000000
+@    s2 errorbar linewidth 1.0
+@    s2 errorbar linestyle 1
+@    s2 errorbar riser linewidth 1.0
+@    s2 errorbar riser linestyle 1
+@    s2 errorbar riser clip off
+@    s2 errorbar riser clip length 0.100000
+@    s2 comment "/tmp/toto"
+@    s2 legend  "infinite"
+ at g1 on
+ at g1 hidden false
+ at g1 type XY
+ at g1 stacked false
+ at g1 bar hgap 0.000000
+ at g1 fixedpoint off
+ at g1 fixedpoint type 0
+ at g1 fixedpoint xy 0.000000, 0.000000
+ at g1 fixedpoint format general general
+ at g1 fixedpoint prec 6, 6
+ at with g1
+@    world 4, 0, 8, 4
+@    stack world 0, 0, 0, 0
+@    znorm 1
+@    view 0.129310, 0.575000, 0.614224, 0.950000
+@    title ""
+@    title font 4
+@    title size 1.500000
+@    title color 1
+@    subtitle ""
+@    subtitle font 4
+@    subtitle size 1.000000
+@    subtitle color 1
+@    xaxes scale Normal
+@    yaxes scale Normal
+@    xaxes invert off
+@    yaxes invert off
+@    xaxis  on
+@    xaxis  type zero false
+@    xaxis  offset 0.000000 , 0.000000
+@    xaxis  bar off
+@    xaxis  bar color 1
+@    xaxis  bar linestyle 1
+@    xaxis  bar linewidth 1.0
+@    xaxis  label "Level"
+@    xaxis  label layout para
+@    xaxis  label place auto
+@    xaxis  label char size 0.600000
+@    xaxis  label font 4
+@    xaxis  label color 1
+@    xaxis  label place normal
+@    xaxis  tick on
+@    xaxis  tick major 1
+@    xaxis  tick minor ticks 1
+@    xaxis  tick default 6
+@    xaxis  tick place rounded true
+@    xaxis  tick in
+@    xaxis  tick major size 1.000000
+@    xaxis  tick major color 1
+@    xaxis  tick major linewidth 1.0
+@    xaxis  tick major linestyle 1
+@    xaxis  tick major grid off
+@    xaxis  tick minor color 1
+@    xaxis  tick minor linewidth 1.0
+@    xaxis  tick minor linestyle 1
+@    xaxis  tick minor grid off
+@    xaxis  tick minor size 0.500000
+@    xaxis  ticklabel on
+@    xaxis  ticklabel format general
+@    xaxis  ticklabel prec 5
+@    xaxis  ticklabel formula ""
+@    xaxis  ticklabel append ""
+@    xaxis  ticklabel prepend ""
+@    xaxis  ticklabel angle 0
+@    xaxis  ticklabel skip 0
+@    xaxis  ticklabel stagger 0
+@    xaxis  ticklabel place normal
+@    xaxis  ticklabel offset auto
+@    xaxis  ticklabel offset 0.000000 , 0.010000
+@    xaxis  ticklabel start type auto
+@    xaxis  ticklabel start 0.000000
+@    xaxis  ticklabel stop type auto
+@    xaxis  ticklabel stop 0.000000
+@    xaxis  ticklabel char size 0.600000
+@    xaxis  ticklabel font 4
+@    xaxis  ticklabel color 1
+@    xaxis  tick place both
+@    xaxis  tick spec type none
+@    yaxis  on
+@    yaxis  type zero false
+@    yaxis  offset 0.000000 , 0.000000
+@    yaxis  bar off
+@    yaxis  bar color 1
+@    yaxis  bar linestyle 1
+@    yaxis  bar linewidth 1.0
+@    yaxis  label "Order"
+@    yaxis  label layout para
+@    yaxis  label place auto
+@    yaxis  label char size 0.600000
+@    yaxis  label font 4
+@    yaxis  label color 1
+@    yaxis  label place normal
+@    yaxis  tick on
+@    yaxis  tick major 1
+@    yaxis  tick minor ticks 1
+@    yaxis  tick default 6
+@    yaxis  tick place rounded true
+@    yaxis  tick in
+@    yaxis  tick major size 1.000000
+@    yaxis  tick major color 1
+@    yaxis  tick major linewidth 1.0
+@    yaxis  tick major linestyle 3
+@    yaxis  tick major grid off
+@    yaxis  tick minor color 1
+@    yaxis  tick minor linewidth 1.0
+@    yaxis  tick minor linestyle 1
+@    yaxis  tick minor grid off
+@    yaxis  tick minor size 0.500000
+@    yaxis  ticklabel on
+@    yaxis  ticklabel format general
+@    yaxis  ticklabel prec 5
+@    yaxis  ticklabel formula ""
+@    yaxis  ticklabel append ""
+@    yaxis  ticklabel prepend ""
+@    yaxis  ticklabel angle 0
+@    yaxis  ticklabel skip 0
+@    yaxis  ticklabel stagger 0
+@    yaxis  ticklabel place normal
+@    yaxis  ticklabel offset auto
+@    yaxis  ticklabel offset 0.000000 , 0.010000
+@    yaxis  ticklabel start type auto
+@    yaxis  ticklabel start 0.000000
+@    yaxis  ticklabel stop type auto
+@    yaxis  ticklabel stop 0.000000
+@    yaxis  ticklabel char size 0.600000
+@    yaxis  ticklabel font 4
+@    yaxis  ticklabel color 1
+@    yaxis  tick place both
+@    yaxis  tick spec type none
+@    altxaxis  off
+@    altyaxis  off
+@    legend on
+@    legend loctype view
+@    legend 0.4, 0.75
+@    legend box color 1
+@    legend box pattern 0
+@    legend box linewidth 1.0
+@    legend box linestyle 1
+@    legend box fill color 0
+@    legend box fill pattern 1
+@    legend font 4
+@    legend char size 0.460000
+@    legend color 1
+@    legend length 4
+@    legend vgap 1
+@    legend hgap 1
+@    legend invert false
+@    frame type 0
+@    frame linestyle 1
+@    frame linewidth 1.0
+@    frame color 1
+@    frame pattern 1
+@    frame background color 0
+@    frame background pattern 0
+@    s0 hidden false
+@    s0 type xy
+@    s0 symbol 1
+@    s0 symbol size 0.340000
+@    s0 symbol color 1
+@    s0 symbol pattern 1
+@    s0 symbol fill color 1
+@    s0 symbol fill pattern 1
+@    s0 symbol linewidth 1.0
+@    s0 symbol linestyle 1
+@    s0 symbol char 0
+@    s0 symbol char font 4
+@    s0 symbol skip 0
+@    s0 line type 1
+@    s0 line linestyle 1
+@    s0 line linewidth 1.0
+@    s0 line color 1
+@    s0 line pattern 1
+@    s0 baseline type 0
+@    s0 baseline off
+@    s0 dropline off
+@    s0 fill type 0
+@    s0 fill rule 0
+@    s0 fill color 1
+@    s0 fill pattern 1
+@    s0 avalue off
+@    s0 avalue type 2
+@    s0 avalue char size 1.000000
+@    s0 avalue font 4
+@    s0 avalue color 1
+@    s0 avalue rot 0
+@    s0 avalue format general
+@    s0 avalue prec 3
+@    s0 avalue prepend ""
+@    s0 avalue append ""
+@    s0 avalue offset 0.000000 , 0.000000
+@    s0 errorbar on
+@    s0 errorbar place both
+@    s0 errorbar color 1
+@    s0 errorbar pattern 1
+@    s0 errorbar size 2.000000
+@    s0 errorbar linewidth 1.0
+@    s0 errorbar linestyle 1
+@    s0 errorbar riser linewidth 1.0
+@    s0 errorbar riser linestyle 1
+@    s0 errorbar riser clip off
+@    s0 errorbar riser clip length 0.100000
+@    s0 comment "/tmp/toto"
+@    s0 legend  "first"
+@    s1 hidden false
+@    s1 type xy
+@    s1 symbol 2
+@    s1 symbol size 0.440000
+@    s1 symbol color 1
+@    s1 symbol pattern 1
+@    s1 symbol fill color 1
+@    s1 symbol fill pattern 1
+@    s1 symbol linewidth 1.0
+@    s1 symbol linestyle 1
+@    s1 symbol char 0
+@    s1 symbol char font 4
+@    s1 symbol skip 0
+@    s1 line type 1
+@    s1 line linestyle 1
+@    s1 line linewidth 1.0
+@    s1 line color 1
+@    s1 line pattern 1
+@    s1 baseline type 0
+@    s1 baseline off
+@    s1 dropline off
+@    s1 fill type 0
+@    s1 fill rule 0
+@    s1 fill color 1
+@    s1 fill pattern 1
+@    s1 avalue off
+@    s1 avalue type 2
+@    s1 avalue char size 1.000000
+@    s1 avalue font 4
+@    s1 avalue color 1
+@    s1 avalue rot 0
+@    s1 avalue format general
+@    s1 avalue prec 3
+@    s1 avalue prepend ""
+@    s1 avalue append ""
+@    s1 avalue offset 0.000000 , 0.000000
+@    s1 errorbar on
+@    s1 errorbar place both
+@    s1 errorbar color 1
+@    s1 errorbar pattern 1
+@    s1 errorbar size 2.000000
+@    s1 errorbar linewidth 1.0
+@    s1 errorbar linestyle 1
+@    s1 errorbar riser linewidth 1.0
+@    s1 errorbar riser linestyle 1
+@    s1 errorbar riser clip off
+@    s1 errorbar riser clip length 0.100000
+@    s1 comment "/tmp/toto"
+@    s1 legend  "second"
+@    s2 hidden false
+@    s2 type xy
+@    s2 symbol 4
+@    s2 symbol size 0.340000
+@    s2 symbol color 1
+@    s2 symbol pattern 1
+@    s2 symbol fill color 1
+@    s2 symbol fill pattern 1
+@    s2 symbol linewidth 1.0
+@    s2 symbol linestyle 1
+@    s2 symbol char 0
+@    s2 symbol char font 4
+@    s2 symbol skip 0
+@    s2 line type 1
+@    s2 line linestyle 1
+@    s2 line linewidth 1.0
+@    s2 line color 1
+@    s2 line pattern 1
+@    s2 baseline type 0
+@    s2 baseline off
+@    s2 dropline off
+@    s2 fill type 0
+@    s2 fill rule 0
+@    s2 fill color 1
+@    s2 fill pattern 1
+@    s2 avalue off
+@    s2 avalue type 2
+@    s2 avalue char size 1.000000
+@    s2 avalue font 4
+@    s2 avalue color 1
+@    s2 avalue rot 0
+@    s2 avalue format general
+@    s2 avalue prec 3
+@    s2 avalue prepend ""
+@    s2 avalue append ""
+@    s2 avalue offset 0.000000 , 0.000000
+@    s2 errorbar on
+@    s2 errorbar place both
+@    s2 errorbar color 1
+@    s2 errorbar pattern 1
+@    s2 errorbar size 2.000000
+@    s2 errorbar linewidth 1.0
+@    s2 errorbar linestyle 1
+@    s2 errorbar riser linewidth 1.0
+@    s2 errorbar riser linestyle 1
+@    s2 errorbar riser clip off
+@    s2 errorbar riser clip length 0.100000
+@    s2 comment "/tmp/toto"
+@    s2 legend  "infinite"
+ at target G0.S0
+ at type xy
+3 1.453e-01
+4 4.368e-02
+5 1.114e-02
+6 2.788e-03
+7 6.981e-04
+8 1.755e-04
+ at target G0.S1
+ at type xy
+3 1.728e-01
+4 5.053e-02
+5 1.274e-02
+6 3.179e-03
+7 7.953e-04
+8 1.999e-04
+ at target G0.S2
+ at type xy
+3 3.309e-01
+4 9.400e-02
+5 2.304e-02
+6 5.703e-03
+7 1.424e-03
+8 3.577e-04
+ at target G1.S0
+ at type xy
+4 1.73399
+5 1.97122
+6 1.99845
+7 1.99772
+8 1.99196
+ at target G1.S1
+ at type xy
+4 1.77389
+5 1.98777
+6 2.00272
+7 1.999
+8 1.99222
+ at target G1.S2
+ at type xy
+4 1.81566
+5 2.02852
+6 2.01435
+7 2.00177
+8 1.99313

-- 
Gerris Flow Solver



More information about the debian-science-commits mailing list