[cig-commits] commit: Rename dRc_dp and dRm_dv to Elastic_d*

Mercurial hg at geodynamics.org
Thu Jun 7 13:35:32 PDT 2012


changeset:   253:3ac6d574b674
user:        Walter Landry <wlandry at caltech.edu>
date:        Tue Jun 05 16:08:46 2012 -0700
files:       src/Elastic_dRc_dp.h src/Elastic_dRm_dv.h src/StokesFACOps/smooth_Tackley_2D.C src/StokesFACOps/smooth_Tackley_3D.C src/StokesFACOps/smooth_V_2D.C src/StokesFACOps/smooth_V_3D.C src/dRc_dp.h src/dRm_dv.h
description:
Rename dRc_dp and dRm_dv to Elastic_d*


diff -r 4bf62b161d54 -r 3ac6d574b674 src/Elastic_dRc_dp.h
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/src/Elastic_dRc_dp.h	Tue Jun 05 16:08:46 2012 -0700
@@ -0,0 +1,96 @@
+#ifndef GAMR_DRC_DP
+#define GAMR_DRC_DP
+
+#include "SAMRAI/pdat/CellData.h"
+#include "SAMRAI/pdat/NodeData.h"
+#include "SAMRAI/pdat/SideData.h"
+#include "Elastic_dRm_dv.h"
+#include "Constants.h"
+
+/* These two functions should really have a more similar API */
+
+/* The derivative of the continuity equation with respect to
+   pressure.  Note that pressure does not appear in the continuity
+   equation, so we use Tackley's method to chain together
+   derivatives */
+
+inline double Elastic_dRc_dp_2D(const SAMRAI::hier::Box &pbox,
+                                const SAMRAI::pdat::CellIndex &center,
+                                const SAMRAI::pdat::SideIndex &x,
+                                const SAMRAI::pdat::SideIndex &y,
+                                SAMRAI::pdat::CellData<double> &cell_viscosity,
+                                SAMRAI::pdat::NodeData<double> &edge_viscosity,
+                                SAMRAI::pdat::SideData<double> &v,
+                                const double &dx,
+                                const double &dy)
+{
+  const SAMRAI::hier::Index ip(1,0), jp(0,1);
+  const SAMRAI::pdat::NodeIndex
+    center_e(center,SAMRAI::pdat::NodeIndex::LowerLeft),
+    up_e(center_e+jp),right_e(center_e+ip);
+    
+  const double dRm_dp_xp(1/dx), dRm_dp_xm(-1/dx),
+    dRm_dp_yp(1/dy), dRm_dp_ym(-1/dy),
+    dRc_dvx_p(-1/dx), dRc_dvx_m(1/dx),
+    dRc_dvy_p(-1/dy), dRc_dvy_m(1/dy);
+
+  double result(0);
+
+  if(!(center[0]==pbox.lower(0) && v(x-ip)==boundary_value))
+    result+=dRc_dvx_m * dRm_dp_xm/Elastic_dRm_dv_2D(cell_viscosity,edge_viscosity,
+                                                    center,center-ip,up_e,center_e,
+                                                    dx,dy);
+
+  if(!(center[0]==pbox.upper(0) && v(x+ip*2)==boundary_value))
+    result+=dRc_dvx_p * dRm_dp_xp/Elastic_dRm_dv_2D(cell_viscosity,edge_viscosity,
+                                                    center+ip,center,up_e+ip,
+                                                    center_e+ip,dx,dy);
+  if(!(center[1]==pbox.lower(1) && v(y-jp)==boundary_value))
+    result+=dRc_dvy_m * dRm_dp_ym/Elastic_dRm_dv_2D(cell_viscosity,edge_viscosity,
+                                                    center,center-jp,right_e,center_e,
+                                                    dy,dx);
+
+  if(!(center[1]==pbox.upper(1) && v(y+jp*2)==boundary_value))
+    result+=dRc_dvy_p * dRm_dp_yp/Elastic_dRm_dv_2D(cell_viscosity,edge_viscosity,
+                                                    center+jp,center,right_e+jp,
+                                                    center_e+jp,dy,dx);
+                                            
+  return result;
+}
+
+
+inline double Elastic_dRc_dp_3D(const SAMRAI::hier::Box &pbox,
+                                const SAMRAI::pdat::CellIndex &center,
+                                SAMRAI::pdat::CellData<double> &cell_viscosity,
+                                SAMRAI::pdat::EdgeData<double> &edge_viscosity,
+                                SAMRAI::pdat::SideData<double> &v,
+                                const double Dx[3],
+                                const SAMRAI::hier::Index pp[3])
+{
+  double result(0);
+  for(int ix=0;ix<3;++ix)
+    {
+      const int iy((ix+1)%3), iz((ix+2)%3);
+      const SAMRAI::pdat::SideIndex x(center,ix,SAMRAI::pdat::SideIndex::Lower);
+      const SAMRAI::pdat::EdgeIndex
+        center_y(center,iy,SAMRAI::pdat::EdgeIndex::LowerLeft),
+        front_y(center_y+pp[iz]),
+        center_z(center,iz,SAMRAI::pdat::EdgeIndex::LowerLeft),
+        up_z(center_z+pp[iy]);
+
+      if(!(center[ix]==pbox.lower(ix) && v(x-pp[ix])==boundary_value))
+        result+=-1.0/(Elastic_dRm_dv_3D(cell_viscosity,edge_viscosity,
+                                        center,center-pp[ix],front_y,center_y,
+                                        up_z,center_z,Dx[ix],Dx[iy],Dx[iz])
+                      * Dx[ix]*Dx[ix]);
+
+      if(!(center[ix]==pbox.upper(ix) && v(x+pp[ix]*2)==boundary_value))
+        result+=-1.0/(Elastic_dRm_dv_3D(cell_viscosity,edge_viscosity,
+                                        center+pp[ix],center,front_y+pp[ix],center_y+pp[ix],
+                                        up_z+pp[ix],center_z+pp[ix],
+                                        Dx[ix],Dx[iy],Dx[iz])
+                      * Dx[ix]*Dx[ix]);
+    }
+  return result;
+}
+#endif
diff -r 4bf62b161d54 -r 3ac6d574b674 src/Elastic_dRm_dv.h
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/src/Elastic_dRm_dv.h	Tue Jun 05 16:08:46 2012 -0700
@@ -0,0 +1,44 @@
+#ifndef GAMR_DRM_DV
+#define GAMR_DRM_DV
+
+#include "SAMRAI/pdat/CellData.h"
+#include "SAMRAI/pdat/EdgeData.h"
+
+/* The derivative of the momentum equation w/respect to velocity. It
+   is written from the perspective of vx(center_x), but pass in
+   different values for center etc. to get vy or vx(!center_x). */
+
+template<class E_data, class E_index>
+double Elastic_dRm_dv_2D(SAMRAI::pdat::CellData<double> &cell_viscosity,
+                         E_data &edge_viscosity,
+                         const SAMRAI::pdat::CellIndex &center,
+                         const SAMRAI::pdat::CellIndex &left,
+                         const E_index &up_e,
+                         const E_index &center_e,
+                         const double &dx,
+                         const double &dy)
+{
+  return -2*(cell_viscosity(center) + cell_viscosity(left))/(dx*dx)
+    - (edge_viscosity(up_e) + edge_viscosity(center_e))/(dy*dy);
+}
+
+inline double Elastic_dRm_dv_3D(SAMRAI::pdat::CellData<double> &cell_viscosity,
+                                SAMRAI::pdat::EdgeData<double> &edge_viscosity,
+                                const SAMRAI::pdat::CellIndex &center,
+                                const SAMRAI::pdat::CellIndex &left,
+                                const SAMRAI::pdat::EdgeIndex &front_y,
+                                const SAMRAI::pdat::EdgeIndex &center_y,
+                                const SAMRAI::pdat::EdgeIndex &up_z,
+                                const SAMRAI::pdat::EdgeIndex &center_z,
+                                const double &dx,
+                                const double &dy,
+                                const double &dz)
+{
+  return Elastic_dRm_dv_2D(cell_viscosity,edge_viscosity,center,left,front_y,center_y,dx,dy)
+    - (edge_viscosity(up_z) + edge_viscosity(center_z))/(dz*dz);
+}
+
+
+
+
+#endif
diff -r 4bf62b161d54 -r 3ac6d574b674 src/StokesFACOps/smooth_Tackley_2D.C
--- a/src/StokesFACOps/smooth_Tackley_2D.C	Tue Jun 05 16:02:47 2012 -0700
+++ b/src/StokesFACOps/smooth_Tackley_2D.C	Tue Jun 05 16:08:46 2012 -0700
@@ -1,6 +1,6 @@
 #include "StokesFACOps.h"
 #include "Constants.h"
-#include "dRc_dp.h"
+#include "Elastic_dRc_dp.h"
 /*
 ********************************************************************
 * Workhorse function to smooth error using red-black               *
@@ -232,7 +232,7 @@ void SAMRAI::solv::StokesFACOps::smooth_
               maxres=std::max(maxres,std::fabs(delta_R_continuity));
 
               dp(center)=delta_R_continuity*theta_continuity
-                /dRc_dp_2D(pbox,center,x,y,cell_viscosity,edge_viscosity,v,dx,dy);
+                /Elastic_dRc_dp_2D(pbox,center,x,y,cell_viscosity,edge_viscosity,v,dx,dy);
               p(center)+=dp(center);
             }
         }
@@ -284,8 +284,8 @@ void SAMRAI::solv::StokesFACOps::smooth_
                        || (center[0]==pbox.upper(0)
                            && v(x+ip)==boundary_value)))
                     v(x)+=(dp(center) - dp(center-ip))
-                      /(dx*dRm_dv_2D(cell_viscosity,edge_viscosity,center,
-                                     center-ip,edge+jp,edge,dx,dy));
+                      /(dx*Elastic_dRm_dv_2D(cell_viscosity,edge_viscosity,center,
+                                             center-ip,edge+jp,edge,dx,dy));
                 }
               if(center[0]<pbox.upper(0))
                 {
@@ -293,32 +293,32 @@ void SAMRAI::solv::StokesFACOps::smooth_
                        || (center[1]==pbox.upper(1)
                            && v(y+jp)==boundary_value)))
                     v(y)+=(dp(center) - dp(center-jp))
-                      /(dy*dRm_dv_2D(cell_viscosity,edge_viscosity,center,
-                                     center-jp,edge+ip,edge,dy,dx));
+                      /(dy*Elastic_dRm_dv_2D(cell_viscosity,edge_viscosity,center,
+                                             center-jp,edge+ip,edge,dy,dx));
                 }
             }
         }
       set_boundaries(invalid_id,v_id,level,true);
 
       // if (residual_tolerance >= 0.0) {
-        /*
-         * Check for early end of sweeps due to convergence
-         * only if it is numerically possible (user gave a
-         * non negative value for residual tolerance).
-         */
-        converged = maxres < residual_tolerance;
-        const tbox::SAMRAI_MPI&
-          mpi(d_hierarchy->getDomainMappedBoxLevel().getMPI());
-        int tmp= converged ? 1 : 0;
-        if (mpi.getSize() > 1)
-          {
-            mpi.AllReduce(&tmp, 1, MPI_MIN);
-          }
-        converged=(tmp==1);
-        // if (d_enable_logging)
-        //   tbox::plog
-        //     // << d_object_name << "\n"
-        //     << "Tackley  " << ln << " " << sweep << " : " << maxres << "\n";
+      /*
+       * Check for early end of sweeps due to convergence
+       * only if it is numerically possible (user gave a
+       * non negative value for residual tolerance).
+       */
+      converged = maxres < residual_tolerance;
+      const tbox::SAMRAI_MPI&
+        mpi(d_hierarchy->getDomainMappedBoxLevel().getMPI());
+      int tmp= converged ? 1 : 0;
+      if (mpi.getSize() > 1)
+        {
+          mpi.AllReduce(&tmp, 1, MPI_MIN);
+        }
+      converged=(tmp==1);
+      // if (d_enable_logging)
+      //   tbox::plog
+      //     // << d_object_name << "\n"
+      //     << "Tackley  " << ln << " " << sweep << " : " << maxres << "\n";
       // }
     }
 }
diff -r 4bf62b161d54 -r 3ac6d574b674 src/StokesFACOps/smooth_Tackley_3D.C
--- a/src/StokesFACOps/smooth_Tackley_3D.C	Tue Jun 05 16:02:47 2012 -0700
+++ b/src/StokesFACOps/smooth_Tackley_3D.C	Tue Jun 05 16:08:46 2012 -0700
@@ -1,6 +1,6 @@
 #include "StokesFACOps.h"
 #include "Constants.h"
-#include "dRc_dp.h"
+#include "Elastic_dRc_dp.h"
 /*
 ********************************************************************
 * Workhorse function to smooth error using red-black               *
@@ -178,7 +178,7 @@ void SAMRAI::solv::StokesFACOps::smooth_
               maxres=std::max(maxres,std::fabs(delta_R_continuity));
 
               dp(center)=delta_R_continuity*theta_continuity
-                /dRc_dp_3D(pbox,center,cell_viscosity,edge_viscosity,v,Dx,pp);
+                /Elastic_dRc_dp_3D(pbox,center,cell_viscosity,edge_viscosity,v,Dx,pp);
               p(center)+=dp(center);
             }
         }
@@ -233,10 +233,10 @@ void SAMRAI::solv::StokesFACOps::smooth_
                            || (center[ix]==pbox.upper(ix)
                                && v(x+pp[ix])==boundary_value)))
                         v(x)+=(dp(center) - dp(center-pp[ix]))
-                          /(Dx[ix]*dRm_dv_3D(cell_viscosity,edge_viscosity,center,
-                                             center-pp[ix],edge_y+pp[iz],edge_y,
-                                             edge_z+pp[iy],edge_z,
-                                             Dx[ix],Dx[iy],Dx[iz]));
+                          /(Dx[ix]*Elastic_dRm_dv_3D(cell_viscosity,edge_viscosity,center,
+                                                     center-pp[ix],edge_y+pp[iz],edge_y,
+                                                     edge_z+pp[iy],edge_z,
+                                                     Dx[ix],Dx[iy],Dx[iz]));
                     }
                 }
             }
@@ -246,24 +246,24 @@ void SAMRAI::solv::StokesFACOps::smooth_
       set_boundaries(invalid_id,v_id,level,true);
 
       // if (residual_tolerance >= 0.0) {
-        /*
-         * Check for early end of sweeps due to convergence
-         * only if it is numerically possible (user gave a
-         * non negative value for residual tolerance).
-         */
-        converged = maxres < residual_tolerance;
-        const tbox::SAMRAI_MPI&
-          mpi(d_hierarchy->getDomainMappedBoxLevel().getMPI());
-        int tmp= converged ? 1 : 0;
-        if (mpi.getSize() > 1)
-          {
-            mpi.AllReduce(&tmp, 1, MPI_MIN);
-          }
-        converged=(tmp==1);
-        // if (d_enable_logging)
-        //   tbox::plog
-        //     // << d_object_name << "\n"
-        //     << "Tackley  " << ln << " " << sweep << " : " << maxres << "\n";
+      /*
+       * Check for early end of sweeps due to convergence
+       * only if it is numerically possible (user gave a
+       * non negative value for residual tolerance).
+       */
+      converged = maxres < residual_tolerance;
+      const tbox::SAMRAI_MPI&
+        mpi(d_hierarchy->getDomainMappedBoxLevel().getMPI());
+      int tmp= converged ? 1 : 0;
+      if (mpi.getSize() > 1)
+        {
+          mpi.AllReduce(&tmp, 1, MPI_MIN);
+        }
+      converged=(tmp==1);
+      // if (d_enable_logging)
+      //   tbox::plog
+      //     // << d_object_name << "\n"
+      //     << "Tackley  " << ln << " " << sweep << " : " << maxres << "\n";
       // }
     }
 }
diff -r 4bf62b161d54 -r 3ac6d574b674 src/StokesFACOps/smooth_V_2D.C
--- a/src/StokesFACOps/smooth_V_2D.C	Tue Jun 05 16:02:47 2012 -0700
+++ b/src/StokesFACOps/smooth_V_2D.C	Tue Jun 05 16:08:46 2012 -0700
@@ -1,6 +1,6 @@
 #include "StokesFACOps.h"
 #include "Constants.h"
-#include "dRm_dv.h"
+#include "Elastic_dRm_dv.h"
 /*
 ********************************************************************
 * Updates one component of the velocity during a red-black *
@@ -53,8 +53,8 @@ void SAMRAI::solv::StokesFACOps::smooth_
           dv_upper=v(x+offset) - v(x);
         }
 
-      double C_vx=dRm_dv_2D(cell_viscosity,edge_viscosity,center,center-ip,
-                            edge+jp,edge,dx,dy);
+      double C_vx=Elastic_dRm_dv_2D(cell_viscosity,edge_viscosity,center,center-ip,
+                                    edge+jp,edge,dx,dy);
 
       double delta_Rx=v_rhs(x)
         - v_operator_2D(v,p,cell_viscosity,edge_viscosity,center,
diff -r 4bf62b161d54 -r 3ac6d574b674 src/StokesFACOps/smooth_V_3D.C
--- a/src/StokesFACOps/smooth_V_3D.C	Tue Jun 05 16:02:47 2012 -0700
+++ b/src/StokesFACOps/smooth_V_3D.C	Tue Jun 05 16:08:46 2012 -0700
@@ -1,6 +1,6 @@
 #include "StokesFACOps.h"
 #include "Constants.h"
-#include "dRm_dv.h"
+#include "Elastic_dRm_dv.h"
 /*
 ********************************************************************
 * Updates one component of the velocity during a red-black *
@@ -51,9 +51,9 @@ void SAMRAI::solv::StokesFACOps::smooth_
           dv_upper=v(x+offset) - v(x);
         }
 
-      double C_vx=dRm_dv_3D(cell_viscosity,edge_viscosity,center,center-pp[ix],
-                            edge_y+pp[iz],edge_y,edge_z+pp[iy],edge_z,
-                            Dx[ix],Dx[iy],Dx[iz]);
+      double C_vx=Elastic_dRm_dv_3D(cell_viscosity,edge_viscosity,center,center-pp[ix],
+                                    edge_y+pp[iz],edge_y,edge_z+pp[iy],edge_z,
+                                    Dx[ix],Dx[iy],Dx[iz]);
 
       double delta_Rx=v_rhs(x)
         - v_operator_3D(v,p,cell_viscosity,edge_viscosity,center,edge_y,edge_z,
diff -r 4bf62b161d54 -r 3ac6d574b674 src/dRc_dp.h
--- a/src/dRc_dp.h	Tue Jun 05 16:02:47 2012 -0700
+++ /dev/null	Thu Jan 01 00:00:00 1970 +0000
@@ -1,96 +0,0 @@
-#ifndef GAMR_DRC_DP
-#define GAMR_DRC_DP
-
-#include "SAMRAI/pdat/CellData.h"
-#include "SAMRAI/pdat/NodeData.h"
-#include "SAMRAI/pdat/SideData.h"
-#include "dRm_dv.h"
-#include "Constants.h"
-
-/* These two functions should really have a more similar API */
-
-/* The derivative of the continuity equation with respect to
-   pressure.  Note that pressure does not appear in the continuity
-   equation, so we use Tackley's method to chain together
-   derivatives */
-
-inline double dRc_dp_2D(const SAMRAI::hier::Box &pbox,
-                        const SAMRAI::pdat::CellIndex &center,
-                        const SAMRAI::pdat::SideIndex &x,
-                        const SAMRAI::pdat::SideIndex &y,
-                        SAMRAI::pdat::CellData<double> &cell_viscosity,
-                        SAMRAI::pdat::NodeData<double> &edge_viscosity,
-                        SAMRAI::pdat::SideData<double> &v,
-                        const double &dx,
-                        const double &dy)
-{
-  const SAMRAI::hier::Index ip(1,0), jp(0,1);
-  const SAMRAI::pdat::NodeIndex
-    center_e(center,SAMRAI::pdat::NodeIndex::LowerLeft),
-    up_e(center_e+jp),right_e(center_e+ip);
-    
-  const double dRm_dp_xp(1/dx), dRm_dp_xm(-1/dx),
-    dRm_dp_yp(1/dy), dRm_dp_ym(-1/dy),
-    dRc_dvx_p(-1/dx), dRc_dvx_m(1/dx),
-    dRc_dvy_p(-1/dy), dRc_dvy_m(1/dy);
-
-  double result(0);
-
-  if(!(center[0]==pbox.lower(0) && v(x-ip)==boundary_value))
-    result+=dRc_dvx_m * dRm_dp_xm/dRm_dv_2D(cell_viscosity,edge_viscosity,
-                                            center,center-ip,up_e,center_e,
-                                            dx,dy);
-
-  if(!(center[0]==pbox.upper(0) && v(x+ip*2)==boundary_value))
-    result+=dRc_dvx_p * dRm_dp_xp/dRm_dv_2D(cell_viscosity,edge_viscosity,
-                                            center+ip,center,up_e+ip,
-                                            center_e+ip,dx,dy);
-  if(!(center[1]==pbox.lower(1) && v(y-jp)==boundary_value))
-    result+=dRc_dvy_m * dRm_dp_ym/dRm_dv_2D(cell_viscosity,edge_viscosity,
-                                            center,center-jp,right_e,center_e,
-                                            dy,dx);
-
-  if(!(center[1]==pbox.upper(1) && v(y+jp*2)==boundary_value))
-    result+=dRc_dvy_p * dRm_dp_yp/dRm_dv_2D(cell_viscosity,edge_viscosity,
-                                            center+jp,center,right_e+jp,
-                                            center_e+jp,dy,dx);
-                                            
-  return result;
-}
-
-
-inline double dRc_dp_3D(const SAMRAI::hier::Box &pbox,
-                        const SAMRAI::pdat::CellIndex &center,
-                        SAMRAI::pdat::CellData<double> &cell_viscosity,
-                        SAMRAI::pdat::EdgeData<double> &edge_viscosity,
-                        SAMRAI::pdat::SideData<double> &v,
-                        const double Dx[3],
-                        const SAMRAI::hier::Index pp[3])
-{
-  double result(0);
-  for(int ix=0;ix<3;++ix)
-    {
-      const int iy((ix+1)%3), iz((ix+2)%3);
-      const SAMRAI::pdat::SideIndex x(center,ix,SAMRAI::pdat::SideIndex::Lower);
-      const SAMRAI::pdat::EdgeIndex
-        center_y(center,iy,SAMRAI::pdat::EdgeIndex::LowerLeft),
-        front_y(center_y+pp[iz]),
-        center_z(center,iz,SAMRAI::pdat::EdgeIndex::LowerLeft),
-        up_z(center_z+pp[iy]);
-
-      if(!(center[ix]==pbox.lower(ix) && v(x-pp[ix])==boundary_value))
-          result+=-1.0/(dRm_dv_3D(cell_viscosity,edge_viscosity,
-                                  center,center-pp[ix],front_y,center_y,
-                                  up_z,center_z,Dx[ix],Dx[iy],Dx[iz])
-                        * Dx[ix]*Dx[ix]);
-
-      if(!(center[ix]==pbox.upper(ix) && v(x+pp[ix]*2)==boundary_value))
-        result+=-1.0/(dRm_dv_3D(cell_viscosity,edge_viscosity,
-                                center+pp[ix],center,front_y+pp[ix],center_y+pp[ix],
-                                up_z+pp[ix],center_z+pp[ix],
-                                Dx[ix],Dx[iy],Dx[iz])
-                      * Dx[ix]*Dx[ix]);
-    }
-  return result;
-}
-#endif
diff -r 4bf62b161d54 -r 3ac6d574b674 src/dRm_dv.h
--- a/src/dRm_dv.h	Tue Jun 05 16:02:47 2012 -0700
+++ /dev/null	Thu Jan 01 00:00:00 1970 +0000
@@ -1,44 +0,0 @@
-#ifndef GAMR_DRM_DV
-#define GAMR_DRM_DV
-
-#include "SAMRAI/pdat/CellData.h"
-#include "SAMRAI/pdat/EdgeData.h"
-
-/* The derivative of the momentum equation w/respect to velocity. It
-   is written from the perspective of vx(center_x), but pass in
-   different values for center etc. to get vy or vx(!center_x). */
-
-template<class E_data, class E_index>
-double dRm_dv_2D(SAMRAI::pdat::CellData<double> &cell_viscosity,
-                 E_data &edge_viscosity,
-                 const SAMRAI::pdat::CellIndex &center,
-                 const SAMRAI::pdat::CellIndex &left,
-                 const E_index &up_e,
-                 const E_index &center_e,
-                 const double &dx,
-                 const double &dy)
-{
-  return -2*(cell_viscosity(center) + cell_viscosity(left))/(dx*dx)
-    - (edge_viscosity(up_e) + edge_viscosity(center_e))/(dy*dy);
-}
-
-inline double dRm_dv_3D(SAMRAI::pdat::CellData<double> &cell_viscosity,
-                        SAMRAI::pdat::EdgeData<double> &edge_viscosity,
-                        const SAMRAI::pdat::CellIndex &center,
-                        const SAMRAI::pdat::CellIndex &left,
-                        const SAMRAI::pdat::EdgeIndex &front_y,
-                        const SAMRAI::pdat::EdgeIndex &center_y,
-                        const SAMRAI::pdat::EdgeIndex &up_z,
-                        const SAMRAI::pdat::EdgeIndex &center_z,
-                        const double &dx,
-                        const double &dy,
-                        const double &dz)
-{
-  return dRm_dv_2D(cell_viscosity,edge_viscosity,center,left,front_y,center_y,dx,dy)
-    - (edge_viscosity(up_z) + edge_viscosity(center_z))/(dz*dz);
-}
-
-
-
-
-#endif



More information about the CIG-COMMITS mailing list