diff --git a/Common/VertexArray.cpp b/Common/VertexArray.cpp
index d642a4108bda677b0b782c899ef3efdf01aecbd2..7cbc4a9d9d95f9a15b09904a70db442f15bd581f 100644
--- a/Common/VertexArray.cpp
+++ b/Common/VertexArray.cpp
@@ -1,4 +1,4 @@
-// $Id: VertexArray.cpp,v 1.18 2007-08-24 20:14:17 geuzaine Exp $
+// $Id: VertexArray.cpp,v 1.19 2007-08-25 10:58:34 geuzaine Exp $
 //
 // Copyright (C) 1997-2007 C. Geuzaine, J.-F. Remacle
 //
@@ -81,18 +81,17 @@ void VertexArray::add(float x, float y, float z, unsigned int col, MElement *ele
   if(ele && CTX.pick_elements) _elements.push_back(ele);
 }
 
-double BarycenterLessThan::tolerance = 0.;
+float BarycenterLessThan::tolerance = 0.;
 
 void VertexArray::add(double *x, double *y, double *z, SVector3 *n,
 		      unsigned int *col, MElement *ele, bool unique)
 {
   int npe = _numVerticesPerElement;
   if(unique){
-    SPoint3 pc(0., 0., 0.);
+    Barycenter pc(0., 0., 0.);
     for(int i = 0; i < npe; i++)
-      pc += SPoint3(x[i], y[i], z[i]);
-    pc /= (double)npe;
-    BarycenterLessThan::tolerance = 1.e-12 * CTX.lc;
+      pc += Barycenter(x[i], y[i], z[i]);
+    BarycenterLessThan::tolerance = 1.e-6 * CTX.lc;
     if(_barycenters.find(pc) != _barycenters.end()) return;
     _barycenters.insert(pc);
   }
diff --git a/Common/VertexArray.h b/Common/VertexArray.h
index 914eeb29933498ca2b6d01e06ea266549da960dc..57ff3487798f8f92c8951ba31aa7a11dd85a58fc 100644
--- a/Common/VertexArray.h
+++ b/Common/VertexArray.h
@@ -26,10 +26,21 @@
 
 class MElement;
 
+class Barycenter {
+ private:
+  float _x, _y, _z;
+ public:
+  Barycenter(double x, double y, double z) : _x(x), _y(y), _z(z){}
+  float x() const { return _x; }
+  float y() const { return _y; }
+  float z() const { return _z; }
+  void operator+=(const Barycenter &p){ _x += p.x(); _y += p.y(); _z += p.z(); }
+};
+
 class BarycenterLessThan{
  public:
-  static double tolerance;
-  bool operator()(const SPoint3 &p1, const SPoint3 &p2) const
+  static float tolerance;
+  bool operator()(const Barycenter &p1, const Barycenter &p2) const
   {
     if(p1.x() - p2.x() >  tolerance) return true;
     if(p1.x() - p2.x() < -tolerance) return false;
@@ -49,7 +60,7 @@ class VertexArray{
   std::vector<char> _normals;
   std::vector<unsigned char> _colors;
   std::vector<MElement*> _elements;
-  std::set<SPoint3, BarycenterLessThan> _barycenters;
+  std::set<Barycenter, BarycenterLessThan> _barycenters;
  public:
   VertexArray(int numVerticesPerElement, int numElements);
   ~VertexArray(){}
diff --git a/Graphics/Draw.cpp b/Graphics/Draw.cpp
index 4ebb99bcbe3c713dff7e93d60e578b4f557cf938..9e11460e4022b42113d0e35338f7b99ef1e83e41 100644
--- a/Graphics/Draw.cpp
+++ b/Graphics/Draw.cpp
@@ -1,4 +1,4 @@
-// $Id: Draw.cpp,v 1.111 2007-08-24 20:14:18 geuzaine Exp $
+// $Id: Draw.cpp,v 1.112 2007-08-25 10:58:34 geuzaine Exp $
 //
 // Copyright (C) 1997-2007 C. Geuzaine, J.-F. Remacle
 //
@@ -51,7 +51,7 @@ int NeedPolygonOffset()
   return 0;
 }
 
-void Draw3d(void)
+void Draw3d()
 {
   // We should only enable the polygon offset when there is a mix of
   // lines and polygons to be drawn; enabling it all the time can lead
@@ -81,7 +81,7 @@ void Draw3d(void)
   Draw_Post();
 }
 
-void Draw2d(void)
+void Draw2d()
 {
   glDisable(GL_DEPTH_TEST);
   for(int i = 0; i < 6; i++)
@@ -104,7 +104,7 @@ void Draw2d(void)
     Draw_SmallAxes();
 }
 
-void DrawPlugin(void (*draw)(void))
+void DrawPlugin(void (*draw)())
 {
   CTX.post.plugin_draw_function = draw;
   int old = CTX.draw_bbox;
@@ -122,7 +122,7 @@ void DrawPlugin(void (*draw)(void))
   CTX.mesh.draw = 1;
 }
 
-void ClearOpengl(void)
+void ClearOpengl()
 {
   glClearColor(CTX.UNPACK_RED(CTX.color.bg) / 255.,
                CTX.UNPACK_GREEN(CTX.color.bg) / 255.,
@@ -254,7 +254,7 @@ void InitProjection(int xpick, int ypick, int wpick, int hpick)
   }
 }
 
-void InitRenderModel(void)
+void InitRenderModel()
 {
   GLfloat r, g, b;
 
@@ -322,7 +322,7 @@ void InitRenderModel(void)
   glDisable(GL_LIGHTING);
 }
 
-void InitPosition(void)
+void InitPosition()
 {
   glScaled(CTX.s[0], CTX.s[1], CTX.s[2]);
   glTranslated(CTX.t[0], CTX.t[1], CTX.t[2]);
diff --git a/Graphics/Post.cpp b/Graphics/Post.cpp
index 113473897881b7155435407dd69a33439a493875..08e891ffd964e96050b4f9266eca2a5dbadfcb30 100644
--- a/Graphics/Post.cpp
+++ b/Graphics/Post.cpp
@@ -1,4 +1,4 @@
-// $Id: Post.cpp,v 1.114 2007-08-24 20:14:18 geuzaine Exp $
+// $Id: Post.cpp,v 1.115 2007-08-25 10:58:34 geuzaine Exp $
 //
 // Copyright (C) 1997-2007 C. Geuzaine, J.-F. Remacle
 //
@@ -75,6 +75,72 @@ SVector3 normal3(double xyz[NMAX][3], int i0=0, int i1=1, int i2=2)
   return n;
 }
 
+void changeCoordinates(PView *p, int nbnod, int nbcomp, 
+		       double xyz[NMAX][3], double val[NMAX][9],
+		       bool offset, bool raise, bool transform)
+{
+  PViewOptions *opt = p->getOptions();
+
+  if(opt->Explode != 1.) {
+    double barycenter[3] = {0., 0., 0.};
+    for(int i = 0; i < nbnod; i++)
+      for(int j = 0; j < 3; j++)
+	barycenter[j] += xyz[i][j];
+    for(int j = 0; j < 3; j++)
+      barycenter[j] /= (double)nbnod;
+    for(int i = 0; i < nbnod; i++)
+      for(int j = 0; j < 3; j++)
+	xyz[i][j] = barycenter[j] + opt->Explode * (xyz[i][j] - barycenter[j]);
+  }
+  
+  if(transform){
+    for(int i = 0; i < nbnod; i++) {
+      double old[3] = {xyz[i][0], xyz[i][1], xyz[i][2]};
+      for(int j = 0; j < 3; j++){
+	xyz[i][j] = 0.;
+	for(int k = 0; k < 3; k++)
+	  xyz[i][j] += opt->Transform[j][k] * old[k];
+      }
+    }
+  }
+  
+  if(offset){
+    for(int i = 0; i < nbnod; i++)
+      for(int j = 0; j < 3; j++)
+	xyz[i][j] += opt->Offset[j];
+  }
+  
+  if(raise){
+    for(int i = 0; i < nbnod; i++){
+      double norm = 0.;
+      if(nbcomp == 1)
+	norm = val[i][0];
+      else if(nbcomp == 3)
+	norm = sqrt(val[i][0] * val[i][0] + 
+		    val[i][1] * val[i][1] + 
+		    val[i][2] * val[i][2]);
+      else if(nbcomp == 9)
+	norm = ComputeVonMises(val[i]);
+      for(int j = 0; j < 3; j++)
+	xyz[i][j] += opt->Raise[j] * norm;
+    }
+  }
+
+  if(opt->UseGenRaise){
+    /* FIXME
+    int ext_nbcomp = nbcomp;
+    double *ext_vals = vals;
+    if(v->ViewIndexForGenRaise >= 0)
+      GetValuesFromExternalView(v, type, nbcomp, &ext_nbcomp, &ext_vals, 
+				v->ViewIndexForGenRaise);
+    ApplyGeneralizedRaise(v, nbnod, ext_nbcomp, ext_vals, x2, y2, z2);
+    */
+  }
+
+  for(int i = 0; i < nbnod; i++)
+    opt->TmpBBox += SPoint3(xyz[i][0], xyz[i][1], xyz[i][2]);
+}
+
 void addScalarPoint(PView *p, double xyz[NMAX][3], double val[NMAX][9])
 {
 }
@@ -110,6 +176,7 @@ void addScalarTriangle(PView *p, double xyz[NMAX][3], double val[NMAX][9],
     if(val[i0][0] >= vmin && val[i0][0] <= vmax &&
        val[i1][0] >= vmin && val[i1][0] <= vmax &&
        val[i2][0] >= vmin && val[i2][0] <= vmax){
+
       // full triangle
       for(int i = 0; i < 3; i++){
 	x[i] = xyz[id[i]][0]; y[i] = xyz[id[i]][1]; z[i] = xyz[id[i]][2]; 
@@ -146,7 +213,6 @@ void addScalarTriangle(PView *p, double xyz[NMAX][3], double val[NMAX][9],
   if(opt->IntervalsType == PViewOptions::Discrete){
     for(int k = 0; k < opt->NbIso; k++){
       if(vmin == vmax) k = opt->NbIso / 2;
-      unsigned int col = opt->getColor(k, opt->NbIso);
       double min = 0.;//FIXME View->GVFI(vmin, vmax, p->NbIso + 1, k);
       double max = 0.;//FIXME View->GVFI(vmin, vmax, p->NbIso + 1, k + 1);
       int nb = cutTriangle(xyz, val, min, max, i0, i1, i2);
@@ -154,15 +220,15 @@ void addScalarTriangle(PView *p, double xyz[NMAX][3], double val[NMAX][9],
 	for(int j = 2; j < nb; j++){
 	  int id2[3] = {0, j - 1, j};
 	  for(int i = 0; i < 3; i++){
-	    double x = xyz[id2[i]][0], y = xyz[id2[i]][1], z = xyz[id2[i]][2];
-	    SVector3 n = ntri;
+	    x[i] = xyz[id2[i]][0]; y[i] = xyz[id2[i]][1]; z[i] = xyz[id2[i]][2];
+	    n[i] = ntri;
 	    if(opt->SmoothNormals){
-	      if(pre) p->normals->add(x, y, z, n[0], n[1], n[2]);
-	      else p->normals->get(x, y, z, n[0], n[1], n[2]);
+	      if(pre) p->normals->add(x[i], y[i], z[i], n[i][0], n[i][1], n[i][2]);
+	      else p->normals->get(x[i], y[i], z[i], n[i][0], n[i][1], n[i][2]);
 	    }
-	    if(!pre)
-	      p->va_triangles->add(x, y, z, n[0], n[1], n[2], col);
+	    col[i] = opt->getColor(k, opt->NbIso);
 	  }
+	  if(!pre) p->va_triangles->add(x, y, z, n, col, 0, col);
 	}
       }
       if(vmin == vmax) break;
@@ -227,6 +293,19 @@ void addElementsInArrays(PView *p, bool preprocessNormalsOnly=false)
     opt->TmpMax = data->getMax();
   }
 
+  // do we need to apply an offset?
+  bool offset = (opt->Offset[0] || opt->Offset[1] || opt->Offset[2]);
+
+  // do we need to apply a simple raise?
+  bool raise = (opt->Raise[0] || opt->Raise[1] || opt->Raise[2]);
+
+  // do we need to apply a general transformation?
+  bool transform = (opt->Transform[0][0] != 1. || opt->Transform[0][1] != 0. || 
+		    opt->Transform[0][2] != 0. || opt->Transform[1][0] != 0. || 
+		    opt->Transform[1][1] != 1. || opt->Transform[1][2] != 0. ||
+		    opt->Transform[2][0] != 0. || opt->Transform[2][1] != 0. || 
+		    opt->Transform[2][2] != 1.);
+
   double xyz[NMAX][3], val[NMAX][9];
 
   for(int i = 0; i < data->getNumElements(); i++){
@@ -238,13 +317,14 @@ void addElementsInArrays(PView *p, bool preprocessNormalsOnly=false)
       for(int k = 0; k < numcomp; k++)
 	data->getValue(i, j, k, step, val[j][k]);
     }
+    changeCoordinates(p, n, numcomp, xyz, val, offset, raise, transform);
     if(numcomp == 1){
       switch(dim){
       case 0: addScalarPoint(p, xyz, val); break;
       case 1: addScalarLine(p, xyz, val); break;
       case 2: 
 	if(n == 3) addScalarTriangle(p, xyz, val, pre);
-	else addScalarQuadrangle(p, xyz, val, pre);
+	else if(n == 4) addScalarQuadrangle(p, xyz, val, pre);
 	break;
       case 3:
 	if(n == 4) addScalarTetrahedron(p, xyz, val, pre);
@@ -365,8 +445,28 @@ class initArraysPView {
   }
 };
 
+static double eyeStored[3] = { 0., 0., 0. };
+
+bool eyeChanged()
+{
+  double zeye = 100 * CTX.lc;
+  double tmp[3] = {CTX.rot[2] * zeye, CTX.rot[6] * zeye, CTX.rot[10] * zeye};
+  if(fabs(tmp[0] - eyeStored[0]) > 1.e-3 ||
+     fabs(tmp[1] - eyeStored[1]) > 1.e-3 ||
+     fabs(tmp[2] - eyeStored[2]) > 1.e-3) {
+    eyeStored[0] = tmp[0];
+    eyeStored[1] = tmp[1];
+    eyeStored[2] = tmp[2];
+    Msg(DEBUG, "New eye = (%g %g %g)", tmp[0], tmp[1], tmp[2]);
+    return true;
+  }
+  return false;
+}
+
 class drawArraysPView {
- public :
+ private:
+  static double _storedEye[3];
+ public:
   void operator () (PView *p)
   {
     PViewData *data = p->getData();
@@ -391,6 +491,12 @@ class drawArraysPView {
       else
 	glDisable((GLenum)(GL_CLIP_PLANE0 + i));
     
+    if(CTX.alpha && ColorTable_IsAlpha(&opt->CT) && 
+       !opt->FakeTransparency && (eyeChanged() || p->getChanged())){
+      Msg(DEBUG, "Sorting View[%d] for transparency", p->getIndex());
+      p->va_triangles->sort(eyeStored);
+    }
+    
     drawArrays(p, p->va_points, GL_POINTS);
     drawArrays(p, p->va_lines, GL_LINES);
     drawArrays(p, p->va_triangles, GL_TRIANGLES);
diff --git a/Numeric/Numeric.cpp b/Numeric/Numeric.cpp
index 7274d758340e529902b12f19ed20bddf2bdfcf3f..ef604fe3b88814124b495b4a1c80c9b98219fb6f 100644
--- a/Numeric/Numeric.cpp
+++ b/Numeric/Numeric.cpp
@@ -1,4 +1,4 @@
-// $Id: Numeric.cpp,v 1.31 2007-01-12 13:16:59 remacle Exp $
+// $Id: Numeric.cpp,v 1.32 2007-08-25 10:58:34 geuzaine Exp $
 //
 // Copyright (C) 1997-2007 C. Geuzaine, J.-F. Remacle
 //
@@ -484,6 +484,17 @@ void gradSimplex(double *x, double *y, double *z, double *v, double *grad)
   sys3x3(mat, b, grad, &det);
 }
 
+double ComputeVonMises(double *V)
+{
+  double tr = (V[0] + V[4] + V[8]) / 3.;
+  double v11 = V[0] - tr, v12 = V[1],      v13 = V[2];
+  double v21 = V[3],      v22 = V[4] - tr, v23 = V[5];
+  double v31 = V[6],      v32 = V[7],      v33 = V[8] - tr;
+  return sqrt(1.5 * (v11 * v11 + v12 * v12 + v13 * v13 +
+                     v21 * v21 + v22 * v22 + v23 * v23 +
+                     v31 * v31 + v32 * v32 + v33 * v33));
+}
+
 void eigenvalue(double mat[3][3], double v[3])
 {            
   // characteristic polynomial of T : find v root of
diff --git a/Numeric/Numeric.h b/Numeric/Numeric.h
index 2829edb7dabb2c0e388ea66bcdb333c3cd442f16..66e147ab057585c1dba1b575cfc5e3ff57088fa2 100644
--- a/Numeric/Numeric.h
+++ b/Numeric/Numeric.h
@@ -90,6 +90,7 @@ double InterpolateIso(double *X, double *Y, double *Z,
 		      double *Val, double V, int I1, int I2, 
 		      double *XI, double *YI ,double *ZI);
 void gradSimplex(double *x, double *y, double *z, double *v, double *grad);
+double ComputeVonMises(double *val);
 
 /* Numerical routines implemented using either Numerical Recipes or
    the GSL */
diff --git a/Post/PViewData.cpp b/Post/PViewData.cpp
index b3625057fcf80e31d534d3e43c7250e1c0699df2..c6e1cd8f1ba533b21981b0389b4eb4c610d73ff8 100644
--- a/Post/PViewData.cpp
+++ b/Post/PViewData.cpp
@@ -1,4 +1,4 @@
-// $Id: PViewData.cpp,v 1.2 2007-08-24 20:14:19 geuzaine Exp $
+// $Id: PViewData.cpp,v 1.3 2007-08-25 10:58:34 geuzaine Exp $
 //
 // Copyright (C) 1997-2007 C. Geuzaine, J.-F. Remacle
 //
@@ -23,6 +23,7 @@
 // 
 
 #include "PViewData.h"
+#include "Numeric.h"
 
 PViewDataList::PViewDataList(bool allocate)
   : DataSize(sizeof(double)), NbTimeStep(0), 
@@ -42,8 +43,12 @@ PViewDataList::PViewDataList(bool allocate)
     NbSI2(0), SI2(0), NbVI2(0), VI2(0), NbTI2(0), TI2(0),
     NbSY(0), SY(0), NbVY(0), VY(0), NbTY(0), TY(0),
     NbSY2(0), SY2(0), NbVY2(0), VY2(0), NbTY2(0), TY2(0),
-    NbT2(0), T2D(0), T2C(0), NbT3(0), T3D(0), T3C(0)
+    NbT2(0), T2D(0), T2C(0), NbT3(0), T3D(0), T3C(0),
+    _lastElement(-1), _lastDimension(-1), _lastNumNodes(-1), 
+    _lastNumComponents(-1), _lastXYZ(0), _lastVal(0)
 {
+  for(int i = 0; i < 24; i++) _index[i] = 0;
+
   if(allocate){
 #define LCD List_Create(1, 1000, sizeof(double))
     Time = LCD;
@@ -115,6 +120,16 @@ void PViewDataList::finalize()
     }
   }
 
+  // compute starting element indices
+  int nb[24] = {NbSP, NbVP, NbTP,  NbSL, NbVL, NbTL,  NbST, NbVT, NbTT, 
+		NbSQ, NbVQ, NbTQ,  NbSS, NbVS, NbTS,  NbSH, NbVH, NbTH, 
+		NbSI, NbVI, NbTI,  NbSY, NbVY, NbTY};
+  for(int i = 0; i < 24; i++){
+    _index[i] = 0;
+    for(int j = 0; j <= i; j++)
+      _index[i] += nb[j];
+  }
+  
   setDirty(false);
 }
 
@@ -158,17 +173,6 @@ void PViewDataList::_stat(List_T *D, List_T *C, int nb)
   }
 }
 
-double vonMises(double *V)
-{
-  double tr = (V[0] + V[4] + V[8]) / 3.;
-  double v11 = V[0] - tr, v12 = V[1],      v13 = V[2];
-  double v21 = V[3],      v22 = V[4] - tr, v23 = V[5];
-  double v31 = V[6],      v32 = V[7],      v33 = V[8] - tr;
-  return sqrt(1.5 * (v11 * v11 + v12 * v12 + v13 * v13 +
-                     v21 * v21 + v22 * v22 + v23 * v23 +
-                     v31 * v31 + v32 * v32 + v33 * v33));
-}
-
 void PViewDataList::_stat(List_T *list, int nbcomp, int nbelm, int nbnod)
 {
   // compute statistics for element lists
@@ -212,7 +216,7 @@ void PViewDataList::_stat(List_T *list, int nbcomp, int nbelm, int nbnod)
       else if(nbcomp == 3)
 	l0 = sqrt(DSQR(V[j]) + DSQR(V[j + 1]) + DSQR(V[j + 2]));
       else
-	l0 = vonMises(V + j); // FIXME: can do better?
+	l0 = ComputeVonMises(V + j); // FIXME: can do better?
       Min = std::min(l0, Min);
       Max = std::max(l0, Max);
       int ts = j / (nbcomp * nbnod);
@@ -224,18 +228,6 @@ void PViewDataList::_stat(List_T *list, int nbcomp, int nbelm, int nbnod)
   }
 }
 
-void PViewDataList::_getListIndices(int index[24])
-{
-  int nb[24] = {NbSP, NbVP, NbTP,  NbSL, NbVL, NbTL,  NbST, NbVT, NbTT, 
-		NbSQ, NbVQ, NbTQ,  NbSS, NbVS, NbTS,  NbSH, NbVH, NbTH, 
-		NbSI, NbVI, NbTI,  NbSY, NbVY, NbTY};
-  for(int i = 0; i < 24; i++){
-    index[i] = 0;
-    for(int j = 0; j <= i; j++)
-      index[i] += nb[j];
-  }
-}
-
 void PViewDataList::_setLast(int ele, int dim, int nbnod, int nbcomp, 
 			     List_T *list, int nblist)
 {
@@ -249,48 +241,46 @@ void PViewDataList::_setLast(int ele, int dim, int nbnod, int nbcomp,
 
 void PViewDataList::_setLast(int ele)
 {
-  int idx[24];
-  _getListIndices(idx);
   _lastElement = ele;
-  if(ele < idx[2]){ // points
-    if(ele < idx[0]) _setLast(ele, 0, 1, 1, SP, NbSP);
-    else if(ele < idx[1]) _setLast(ele - idx[0], 0, 1, 3, VP, NbVP);
-    else _setLast(ele - idx[1], 0, 1, 9, TP, NbTP);
+  if(ele < _index[2]){ // points
+    if(ele < _index[0]) _setLast(ele, 0, 1, 1, SP, NbSP);
+    else if(ele < _index[1]) _setLast(ele - _index[0], 0, 1, 3, VP, NbVP);
+    else _setLast(ele - _index[1], 0, 1, 9, TP, NbTP);
   }
-  else if(ele < idx[5]){ // lines
-    if(ele < idx[3]) _setLast(ele - idx[2], 1, 2, 1, SL, NbSL);
-    else if(ele < idx[4]) _setLast(ele - idx[3], 1, 2, 3, VL, NbVL);
-    else _setLast(ele - idx[4], 1, 2, 9, TL, NbTL);
+  else if(ele < _index[5]){ // lines
+    if(ele < _index[3]) _setLast(ele - _index[2], 1, 2, 1, SL, NbSL);
+    else if(ele < _index[4]) _setLast(ele - _index[3], 1, 2, 3, VL, NbVL);
+    else _setLast(ele - _index[4], 1, 2, 9, TL, NbTL);
   }
-  else if(ele < idx[8]){ // triangles
-    if(ele < idx[6]) _setLast(ele - idx[5], 2, 3, 1, ST, NbST);
-    else if(ele < idx[7]) _setLast(ele - idx[6], 2, 3, 3, VT, NbVT);
-    else _setLast(ele - idx[7], 2, 3, 9, TT, NbTT);
+  else if(ele < _index[8]){ // triangles
+    if(ele < _index[6]) _setLast(ele - _index[5], 2, 3, 1, ST, NbST);
+    else if(ele < _index[7]) _setLast(ele - _index[6], 2, 3, 3, VT, NbVT);
+    else _setLast(ele - _index[7], 2, 3, 9, TT, NbTT);
   }
-  else if(ele < idx[11]){ // quadrangles
-    if(ele < idx[9]) _setLast(ele - idx[8], 2, 4, 1, SQ, NbSQ);
-    else if(ele < idx[10]) _setLast(ele - idx[9], 2, 4, 3, VQ, NbVQ);
-    else _setLast(ele - idx[10], 2, 4, 9, TQ, NbTQ);
+  else if(ele < _index[11]){ // quadrangles
+    if(ele < _index[9]) _setLast(ele - _index[8], 2, 4, 1, SQ, NbSQ);
+    else if(ele < _index[10]) _setLast(ele - _index[9], 2, 4, 3, VQ, NbVQ);
+    else _setLast(ele - _index[10], 2, 4, 9, TQ, NbTQ);
   }
-  else if(ele < idx[14]){ // tetrahedra
-    if(ele < idx[12]) _setLast(ele - idx[11], 3, 4, 1, SS, NbSS);
-    else if(ele < idx[13]) _setLast(ele - idx[12], 3, 4, 3, VS, NbVS);
-    else _setLast(ele - idx[13], 3, 2, 9, TS, NbTS);
+  else if(ele < _index[14]){ // tetrahedra
+    if(ele < _index[12]) _setLast(ele - _index[11], 3, 4, 1, SS, NbSS);
+    else if(ele < _index[13]) _setLast(ele - _index[12], 3, 4, 3, VS, NbVS);
+    else _setLast(ele - _index[13], 3, 2, 9, TS, NbTS);
   }
-  else if(ele < idx[17]){ // hexahedra
-    if(ele < idx[15]) _setLast(ele - idx[14], 3, 8, 1, SH, NbSH);
-    else if(ele < idx[16]) _setLast(ele - idx[15], 3, 8, 3, VH, NbVH);
-    else _setLast(ele - idx[16], 3, 8, 9, TH, NbTH);
+  else if(ele < _index[17]){ // hexahedra
+    if(ele < _index[15]) _setLast(ele - _index[14], 3, 8, 1, SH, NbSH);
+    else if(ele < _index[16]) _setLast(ele - _index[15], 3, 8, 3, VH, NbVH);
+    else _setLast(ele - _index[16], 3, 8, 9, TH, NbTH);
   }
-  else if(ele < idx[20]){ // prisms
-    if(ele < idx[18]) _setLast(ele - idx[17], 3, 6, 1, SI, NbSI);
-    else if(ele < idx[19]) _setLast(ele - idx[18], 3, 6, 3, VI, NbVI);
-    else _setLast(ele - idx[19], 3, 6, 9, TI, NbTI);
+  else if(ele < _index[20]){ // prisms
+    if(ele < _index[18]) _setLast(ele - _index[17], 3, 6, 1, SI, NbSI);
+    else if(ele < _index[19]) _setLast(ele - _index[18], 3, 6, 3, VI, NbVI);
+    else _setLast(ele - _index[19], 3, 6, 9, TI, NbTI);
   }
   else{ // pyramids
-    if(ele < idx[21]) _setLast(ele - idx[20], 3, 5, 1, SY, NbSY);
-    else if(ele < idx[22]) _setLast(ele - idx[21], 3, 5, 3, VY, NbVY);
-    else _setLast(ele - idx[22], 3, 5, 9, TY, NbTY);
+    if(ele < _index[21]) _setLast(ele - _index[20], 3, 5, 1, SY, NbSY);
+    else if(ele < _index[22]) _setLast(ele - _index[21], 3, 5, 3, VY, NbVY);
+    else _setLast(ele - _index[22], 3, 5, 9, TY, NbTY);
   }
 }
 
diff --git a/Post/PViewData.h b/Post/PViewData.h
index f1d3bb3ee86ee4d8fefc5de07965caa0c9cce23a..b29e82371fa4a10e1f3f3ecff74edb39a0072f0f 100644
--- a/Post/PViewData.h
+++ b/Post/PViewData.h
@@ -94,13 +94,13 @@ class PViewDataList : public PViewData {
   std::map<int, List_T*> *Grains; // For LMGC90, grains shapes
   std::map<int, int> *DisplayListsOfGrains; // For LMGC90, grains shapes
  private:
+  int _index[24];
   int _lastElement, _lastDimension, _lastNumNodes, _lastNumComponents;
   double *_lastXYZ, *_lastVal;
   void _stat(List_T *D, List_T *C, int nb);
   void _stat(List_T *list, int nbcomp, int nbelm, int nbnod);
   void _setLast(int ele);
   void _setLast(int ele, int dim, int nbnod, int nbcomp, List_T *list, int nblist);
-  void _getListIndices(int index[24]);
  public:
   PViewDataList(bool allocate=true);
   ~PViewDataList();
diff --git a/Post/PViewOptions.cpp b/Post/PViewOptions.cpp
index b2a5f873726f58f3656ba47efb6e593a9002a510..538d5a8b625804565af0974d196b434a2324eb42 100644
--- a/Post/PViewOptions.cpp
+++ b/Post/PViewOptions.cpp
@@ -1,4 +1,4 @@
-// $Id: PViewOptions.cpp,v 1.2 2007-08-24 20:14:19 geuzaine Exp $
+// $Id: PViewOptions.cpp,v 1.3 2007-08-25 10:58:34 geuzaine Exp $
 //
 // Copyright (C) 1997-2007 C. Geuzaine, J.-F. Remacle
 //
@@ -34,7 +34,7 @@ PViewOptions::PViewOptions()
   for(int i = 0; i < 3; i++){
     Offset[i] = Raise[i] = 0.;
     for(int j = 0; j < 3; j++){
-      Transform[i][j] = 0.;
+      Transform[i][j] = (i == j) ? 1. : 0.;
     }
   }
   DisplacementFactor = 0.;
diff --git a/Post/PViewOptions.h b/Post/PViewOptions.h
index 793258806e150ea962f161760ec8348da65ff96b..c35bfdcc8613101a37b7bcf1515525613923cbbf 100644
--- a/Post/PViewOptions.h
+++ b/Post/PViewOptions.h
@@ -22,6 +22,7 @@
 
 #include <string>
 #include "ColorTable.h"
+#include "SBoundingBox3d.h"
 
 class PViewOptions {
  public:
@@ -78,6 +79,7 @@ class PViewOptions {
   char AxesFormat[3][256], AxesLabel[3][256];
   double AxesPosition[6];
   double CustomMin, CustomMax, TmpMin, TmpMax;
+  SBoundingBox3d TmpBBox;
   double Offset[3], Raise[3], Transform[3][3], DisplacementFactor, Explode;
   double ArrowSize, ArrowRelHeadRadius, ArrowRelStemRadius, ArrowRelStemLength;
   double Normals, Tangents;
diff --git a/Post/Views.cpp b/Post/Views.cpp
index 2364bbcfdd8f0aa895fa890d9702b97868e4027e..55bf252dd30d4226e8ab505f74fc9b9c93d51efa 100644
--- a/Post/Views.cpp
+++ b/Post/Views.cpp
@@ -1,4 +1,4 @@
-// $Id: Views.cpp,v 1.1 2007-07-09 13:54:37 geuzaine Exp $
+// $Id: Views.cpp,v 1.2 2007-08-25 10:58:34 geuzaine Exp $
 //
 // Copyright (C) 1997-2007 C. Geuzaine, J.-F. Remacle
 //
@@ -180,24 +180,6 @@ void Post_View::reset_normals()
   normals = new smooth_normals(AngleSmoothNormals);
 }
 
-double ComputeVonMises(double *V)
-{
-  static const double THIRD = 1.e0 / 3.e0;
-  double tr = (V[0] + V[4] + V[8]) * THIRD;
-  double v11 = V[0] - tr;
-  double v12 = V[1];
-  double v13 = V[2];
-  double v21 = V[3];
-  double v22 = V[4] - tr;
-  double v23 = V[5];
-  double v31 = V[6];
-  double v32 = V[7];
-  double v33 = V[8] - tr;
-  return sqrt(1.5 * (v11 * v11 + v12 * v12 + v13 * v13 +
-                     v21 * v21 + v22 * v22 + v23 * v23 +
-                     v31 * v31 + v32 * v32 + v33 * v33));
-}
-  
 void Stat_Element(Post_View *v, int type, int nbnod, int N,
                   double *X, double *Y, double *Z, double *V)
 {
diff --git a/Post/Views.h b/Post/Views.h
index 3ba4b108997e317dbcd5857126ad7df4d5125bbd..8b6ff040eb0e868b45ef1d2d127016a7d8947e22 100644
--- a/Post/Views.h
+++ b/Post/Views.h
@@ -221,8 +221,6 @@ Post_View *Create2DGraph(char *xname, char *yname, int nbdata, double *x, double
 GmshColorTable *Get_ColorTable(int num);
 void Print_ColorTable(int num, int diff, char *prefix, FILE *file);
 
-double ComputeVonMises(double* val);
-
 void InitGeneralizedRaise(Post_View *v);
 void FreeGeneralizedRaise(Post_View *v);
 void ApplyGeneralizedRaise(Post_View * v, int numNodes, int numComp, double *vals,