[cig-commits] r13364 - in short/3D/PyLith/benchmarks/trunk: . static static/sceccvmh

brad at geodynamics.org brad at geodynamics.org
Thu Nov 20 16:40:19 PST 2008


Author: brad
Date: 2008-11-20 16:40:19 -0800 (Thu, 20 Nov 2008)
New Revision: 13364

Added:
   short/3D/PyLith/benchmarks/trunk/static/
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/README
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/dislocation_slip.spatialdb
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/dislocation_sliptime.spatialdb
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/mat_homogeneous.spatialdb
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_dislocation.cfg
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_geometry.jou
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_hex8.exo.gz
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_hex8.jou
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_dislocation.cfg
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_geometry.jou
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_hex8.exo.gz
   short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_hex8.jou
Log:
Added SCEC CVM-H test problem to static directory.

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/README
===================================================================
--- short/3D/PyLith/benchmarks/trunk/static/sceccvmh/README	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/static/sceccvmh/README	2008-11-21 00:40:19 UTC (rev 13364)
@@ -0,0 +1,12 @@
+These problems test using physical properties from the SCEC CVM-H with
+PyLith via a static problem.
+
+One problem (volume_dislocation.cfg) is a domain 48km x 48km x 16km
+with Dirichlet BC imposing shear with slip on a fault.
+
+The second problem (slice_dislocation.cfg) is a domain 256km x 128km x
+0.5 km with similar BC. The solution fails to converge due to the
+small aspect ratio of the domain, but it samples the velocity model at
+shallow depths, which is important for dealing with potential
+incompressibility of very soft sediments.
+

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/dislocation_slip.spatialdb
===================================================================
--- short/3D/PyLith/benchmarks/trunk/static/sceccvmh/dislocation_slip.spatialdb	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/static/sceccvmh/dislocation_slip.spatialdb	2008-11-21 00:40:19 UTC (rev 13364)
@@ -0,0 +1,19 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  num-values = 3
+  value-names =  left-lateral-slip reverse-slip fault-opening
+  value-units =  m  m m
+  num-locs = 1
+  data-dim = 0
+  space-dim = 3
+  cs-data = geo-projected {
+    ellipsoid = WGS84
+    datum-horiz = WGS84
+    datum-vert = mean sea level
+    projector = projection {
+      projection = tmerc
+      proj-options = +lon_0=-118.2467 +lat_0=34.0550
+    }
+  }
+}
+0.0  0.0  0.0   -2.0  0.0  0.0

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/dislocation_sliptime.spatialdb
===================================================================
--- short/3D/PyLith/benchmarks/trunk/static/sceccvmh/dislocation_sliptime.spatialdb	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/static/sceccvmh/dislocation_sliptime.spatialdb	2008-11-21 00:40:19 UTC (rev 13364)
@@ -0,0 +1,19 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  num-values = 1
+  value-names =  slip-time
+  value-units =  s
+  num-locs = 1
+  data-dim = 0
+  space-dim = 3
+  cs-data = geo-projected {
+    ellipsoid = WGS84
+    datum-horiz = WGS84
+    datum-vert = mean sea level
+    projector = projection {
+      projection = tmerc
+      proj-options = +lon_0=-118.2467 +lat_0=34.0550
+    }
+  }
+}
+0.0  0.0  0.0   -1.0

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/mat_homogeneous.spatialdb
===================================================================
--- short/3D/PyLith/benchmarks/trunk/static/sceccvmh/mat_homogeneous.spatialdb	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/static/sceccvmh/mat_homogeneous.spatialdb	2008-11-21 00:40:19 UTC (rev 13364)
@@ -0,0 +1,19 @@
+#SPATIAL.ascii 1
+SimpleDB {
+  num-values = 3
+  value-names =  density vs vp
+  value-units =  kg/m^3  m/s  m/s
+  num-locs = 1
+  data-dim = 0
+  space-dim = 3
+  cs-data = geo-projected {
+    ellipsoid = WGS84
+    datum-horiz = WGS84
+    datum-vert = mean sea level
+    projector = projection {
+      projection = tmerc
+      proj-options = +lon_0=-118.2467 +lat_0=34.0550
+    }
+  }
+}
+0.0  0.0  0.0   2500.0  3000.0  5291.502622129181

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_dislocation.cfg
===================================================================
--- short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_dislocation.cfg	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_dislocation.cfg	2008-11-21 00:40:19 UTC (rev 13364)
@@ -0,0 +1,153 @@
+# -*- Python -*-
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+[pylithapp.journal.info]
+timedependent = 1
+implicit = 1
+petsc = 1
+solverlinear = 1
+meshiocubit = 1
+implicitelasticity = 1
+#quadrature3d = 1
+#fiatlagrange = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[pylithapp.mesh_generator]
+#debug = 1
+importer = pylith.meshio.MeshIOCubit
+
+[pylithapp.mesh_generator.importer]
+filename = slice_hex8.exo
+
+coordsys = spatialdata.geocoords.CSGeoProj
+coordsys.projector.projection = tmerc
+coordsys.projector.proj-options = +lon_0=-118.2467 +lat_0=34.0550
+coordsys.datum_vert = mean sea level
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+dimension = 3
+bc = [bc_east,bc_west,bc_bottom,bc_ground]
+interfaces = [fault]
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+materials = [elastic]
+materials.elastic = pylith.materials.ElasticIsotropic3D
+
+[pylithapp.timedependent.materials.elastic]
+label = Elastic material
+id = 1
+
+db = spatialdata.spatialdb.SCECCVMH
+db.data_dir = /home/brad/data/sceccvm-h/vx53/bin
+db.squash = True
+db.squash_limit = -8.0*km
+#db = spatialdata.spatialdb.SimpleDB
+#db.iohandler.filename = mat_homogeneous.spatialdb
+
+quadrature = pylith.feassemble.quadrature.Quadrature3D
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 3
+quadrature.cell.quad_order = 2
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.bc_east]
+fixed_dof = [0, 1]
+label = 21
+db = spatialdata.spatialdb.UniformDB
+db.label = Dirichlet BC east surface
+db.values = [dof-0,dof-1]
+db.data = [0.0,-2.0]
+
+[pylithapp.timedependent.bc.bc_west]
+fixed_dof = [0, 1]
+label = 22
+db = spatialdata.spatialdb.UniformDB
+db.label = Dirichlet BC west surface
+db.values = [dof-0,dof-1]
+db.data = [0.0,+2.0]
+
+[pylithapp.timedependent.bc.bc_bottom]
+fixed_dof = [2]
+label = 26
+db = spatialdata.spatialdb.UniformDB
+db.label = Dirichlet BC bottom surface
+db.values = [dof-2]
+db.data = [0.0]
+
+[pylithapp.timedependent.bc.bc_ground]
+fixed_dof = [2]
+label = 25
+db = spatialdata.spatialdb.UniformDB
+db.label = Dirichlet BC ground surface
+db.values = [dof-2]
+db.data = [0.0]
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.interfaces]
+fault = pylith.faults.FaultCohesiveKin
+
+[pylithapp.timedependent.interfaces.fault]
+id = 2
+label = 10
+quadrature = pylith.feassemble.quadrature.Quadrature2Din3D
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 2
+quadrature.cell.quad_order = 2
+
+#mat_db = spatialdata.spatialdb.SCECCVMH
+#mat_db.data_dir = /home/brad/data/sceccvm-h/vx53/bin
+#mat_db.squash = True
+#mat_db.squash_limit = -8.0*km
+mat_db = spatialdata.spatialdb.SimpleDB
+mat_db.iohandler.filename = mat_homogeneous.spatialdb
+
+[pylithapp.timedependent.interfaces.fault.eq_srcs.rupture.slip_function]
+slip.iohandler.filename = dislocation_slip.spatialdb
+slip_time.iohandler.filename = dislocation_sliptime.spatialdb
+
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+[pylithapp.petsc]
+ksp_rtol = 1.0e-8
+pc_type = asm
+ksp_max_it = 200
+ksp_gmres_restart = 50
+ksp_monitor = true
+ksp_view = true
+log_summary = true
+# start_in_debugger = true
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output.writer]
+filename = slice-dislocation.vtk
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+cell_filter = pylith.meshio.CellFilterAvg
+writer.filename = slice-dislocation-statevars-elastic.vtk
+
+[pylithapp.timedependent.interfaces.fault.output.writer]
+filename = slice-dislocation-fault.vtk

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_geometry.jou
===================================================================
--- short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_geometry.jou	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_geometry.jou	2008-11-21 00:40:19 UTC (rev 13364)
@@ -0,0 +1,28 @@
+# ----------------------------------------------------------------------
+# Create block
+# ----------------------------------------------------------------------
+reset
+brick x 256e+3 y 128e+3 z 500.0
+volume 1 move x 103e+3 y 10e+3 z -250.0
+
+# ----------------------------------------------------------------------
+# Create interface surfaces
+# ----------------------------------------------------------------------
+create vertex 100.0e+3   60.0e+3      0.0
+create vertex 150.0e+3  -54.0e+3      0.0
+create vertex 150.0e+3  -54.0e+3  -1000.0
+create planar surface with plane vertex 9 vertex 10 vertex 11
+delete vertex all
+surface 7 name "fault_surface"
+
+# ----------------------------------------------------------------------
+# Divide volumes using interfaces surfaces
+# ----------------------------------------------------------------------
+webcut volume 1 with plane surface fault_surface
+
+# ----------------------------------------------------------------------
+# Imprint curves on volumes
+# ----------------------------------------------------------------------
+imprint all with volume all
+merge all
+delete body 2

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_hex8.exo.gz
===================================================================
(Binary files differ)


Property changes on: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_hex8.exo.gz
___________________________________________________________________
Name: svn:mime-type
   + application/octet-stream

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_hex8.jou
===================================================================
--- short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_hex8.jou	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/static/sceccvmh/slice_hex8.jou	2008-11-21 00:40:19 UTC (rev 13364)
@@ -0,0 +1,67 @@
+# ----------------------------------------------------------------------
+# Generate geometry
+# ----------------------------------------------------------------------
+playback 'slice_geometry.jou'
+
+# ----------------------------------------------------------------------
+# Set discretization size
+# ----------------------------------------------------------------------
+surface 9 11 15 16 scheme pave
+surface all size 1000
+volume all size 1000
+
+# ----------------------------------------------------------------------
+# Generate the mesh
+# ----------------------------------------------------------------------
+mesh volume all
+
+# ----------------------------------------------------------------------
+# Generate blocks and nodesets
+# ----------------------------------------------------------------------
+block 1 volume 1 3
+block 1 name "elastic"
+
+# ----------------------------------------------------------------------
+# Create nodeset for fault
+# ----------------------------------------------------------------------
+group "fault" add node in fault_surface
+nodeset 10 group fault
+nodeset 10 name "fault"
+
+# ----------------------------------------------------------------------
+# Create nodeset for BC
+# ----------------------------------------------------------------------
+group "surf_east" add node in surface 6
+nodeset 21 group surf_east
+nodeset 21 name "surf_east"
+
+group "surf_west" add node in surface 4
+nodeset 22 group surf_west
+nodeset 22 name "surf_west"
+
+group "surf_north" add node in surface 14
+group "surf_north" add node in surface 12
+group "surf_north" remove node in fault
+nodeset 23 group surf_north
+nodeset 23 name "surf_north"
+
+group "surf_south" add node in surface 17
+group "surf_south" add node in surface 10
+group "surf_south" remove node in fault
+nodeset 24 group surf_south
+nodeset 24 name "surf_south"
+
+group "surf_ground" add node in surface 16
+group "surf_ground" add node in surface 9
+nodeset 25 group surf_ground
+nodeset 25 name "surf_ground"
+
+group "surf_bottom" add node in surface 15
+group "surf_bottom" add node in surface 11
+nodeset 26 group surf_bottom
+nodeset 26 name "surf_bottom"
+
+# ----------------------------------------------------------------------
+# Export exodus file
+# ----------------------------------------------------------------------
+export mesh "slice_hex8.exo" dimension 3 overwrite

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_dislocation.cfg
===================================================================
--- short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_dislocation.cfg	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_dislocation.cfg	2008-11-21 00:40:19 UTC (rev 13364)
@@ -0,0 +1,145 @@
+# -*- Python -*-
+[pylithapp]
+
+# ----------------------------------------------------------------------
+# journal
+# ----------------------------------------------------------------------
+[pylithapp.journal.info]
+timedependent = 1
+implicit = 1
+petsc = 1
+solverlinear = 1
+meshiocubit = 1
+implicitelasticity = 1
+#quadrature3d = 1
+#fiatlagrange = 1
+
+# ----------------------------------------------------------------------
+# mesh_generator
+# ----------------------------------------------------------------------
+[pylithapp.mesh_generator]
+#debug = 1
+importer = pylith.meshio.MeshIOCubit
+
+[pylithapp.mesh_generator.importer]
+filename = volume_hex8.exo
+
+coordsys = spatialdata.geocoords.CSGeoProj
+coordsys.projector.projection = tmerc
+coordsys.projector.proj-options = +lon_0=-118.2467 +lat_0=34.0550
+coordsys.datum_vert = mean sea level
+
+# ----------------------------------------------------------------------
+# problem
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+dimension = 3
+bc = [bc_east,bc_west,bc_bottom]
+interfaces = [fault]
+
+[pylithapp.timedependent.formulation.time_step]
+total_time = 0.0*s
+
+# ----------------------------------------------------------------------
+# materials
+# ----------------------------------------------------------------------
+[pylithapp.timedependent]
+materials = [elastic]
+materials.elastic = pylith.materials.ElasticIsotropic3D
+
+[pylithapp.timedependent.materials.elastic]
+label = Elastic material
+id = 1
+
+db = spatialdata.spatialdb.SCECCVMH
+db.data_dir = /home/brad/data/sceccvm-h/vx53/bin
+db.squash = True
+db.squash_limit = -8.0*km
+#db = spatialdata.spatialdb.SimpleDB
+#db.iohandler.filename = mat_homogeneous.spatialdb
+
+quadrature = pylith.feassemble.quadrature.Quadrature3D
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 3
+quadrature.cell.quad_order = 2
+
+# ----------------------------------------------------------------------
+# boundary conditions
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.bc.bc_east]
+fixed_dof = [0, 1]
+label = 21
+db = spatialdata.spatialdb.UniformDB
+db.label = Dirichlet BC east surface
+db.values = [dof-0,dof-1]
+db.data = [0.0,-2.0]
+
+[pylithapp.timedependent.bc.bc_west]
+fixed_dof = [0, 1]
+label = 22
+db = spatialdata.spatialdb.UniformDB
+db.label = Dirichlet BC west surface
+db.values = [dof-0,dof-1]
+db.data = [0.0,+2.0]
+
+[pylithapp.timedependent.bc.bc_bottom]
+fixed_dof = [2]
+label = 26
+db = spatialdata.spatialdb.UniformDB
+db.label = Dirichlet BC bottom surface
+db.values = [dof-2]
+db.data = [0.0]
+
+# ----------------------------------------------------------------------
+# faults
+# ----------------------------------------------------------------------
+[pylithapp.timedependent.interfaces]
+fault = pylith.faults.FaultCohesiveKin
+
+[pylithapp.timedependent.interfaces.fault]
+id = 2
+label = 10
+quadrature = pylith.feassemble.quadrature.Quadrature2Din3D
+quadrature.cell = pylith.feassemble.FIATLagrange
+quadrature.cell.dimension = 2
+quadrature.cell.quad_order = 2
+
+#mat_db = spatialdata.spatialdb.SCECCVMH
+#mat_db.data_dir = /home/brad/data/sceccvm-h/vx53/bin
+#mat_db.squash = True
+#mat_db.squash_limit = -8.0*km
+mat_db = spatialdata.spatialdb.SimpleDB
+mat_db.iohandler.filename = mat_homogeneous.spatialdb
+
+[pylithapp.timedependent.interfaces.fault.eq_srcs.rupture.slip_function]
+slip.iohandler.filename = dislocation_slip.spatialdb
+slip_time.iohandler.filename = dislocation_sliptime.spatialdb
+
+
+# ----------------------------------------------------------------------
+# PETSc
+# ----------------------------------------------------------------------
+[pylithapp.petsc]
+ksp_rtol = 1.0e-8
+pc_type = asm
+ksp_max_it = 200
+ksp_gmres_restart = 50
+ksp_monitor = true
+ksp_view = true
+log_summary = true
+# start_in_debugger = true
+
+# ----------------------------------------------------------------------
+# output
+# ----------------------------------------------------------------------
+# Give basename for VTK domain output of solution over domain.
+[pylithapp.problem.formulation.output.output.writer]
+filename = volume-dislocation.vtk
+
+# Give basename for VTK output of state variables.
+[pylithapp.timedependent.materials.elastic.output]
+cell_filter = pylith.meshio.CellFilterAvg
+writer.filename = volume-dislocation-statevars-elastic.vtk
+
+[pylithapp.timedependent.interfaces.fault.output.writer]
+filename = volume-dislocation-fault.vtk

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_geometry.jou
===================================================================
--- short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_geometry.jou	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_geometry.jou	2008-11-21 00:40:19 UTC (rev 13364)
@@ -0,0 +1,28 @@
+# ----------------------------------------------------------------------
+# Create block
+# ----------------------------------------------------------------------
+reset
+brick x 48000 y 48000 z 16000
+volume 1 move x -1000 y -30000 z -8000
+
+# ----------------------------------------------------------------------
+# Create interface surfaces
+# ----------------------------------------------------------------------
+create vertex -8000.0  -6000.0      0.0
+create vertex  6000.0 -54000.0      0.0
+create vertex  6000.0 -54000.0 -16000.0
+create planar surface with plane vertex 9 vertex 10 vertex 11
+delete vertex all
+surface 7 name "fault_surface"
+
+# ----------------------------------------------------------------------
+# Divide volumes using interfaces surfaces
+# ----------------------------------------------------------------------
+webcut volume 1 with plane surface fault_surface
+
+# ----------------------------------------------------------------------
+# Imprint curves on volumes
+# ----------------------------------------------------------------------
+imprint all with volume all
+merge all
+delete body 2

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_hex8.exo.gz
===================================================================
(Binary files differ)


Property changes on: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_hex8.exo.gz
___________________________________________________________________
Name: svn:mime-type
   + application/octet-stream

Added: short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_hex8.jou
===================================================================
--- short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_hex8.jou	                        (rev 0)
+++ short/3D/PyLith/benchmarks/trunk/static/sceccvmh/volume_hex8.jou	2008-11-21 00:40:19 UTC (rev 13364)
@@ -0,0 +1,67 @@
+# ----------------------------------------------------------------------
+# Generate geometry
+# ----------------------------------------------------------------------
+playback 'volume_geometry.jou'
+
+# ----------------------------------------------------------------------
+# Set discretization size
+# ----------------------------------------------------------------------
+surface 9 11 15 16 scheme pave
+surface all size 1000
+volume all size 1000
+
+# ----------------------------------------------------------------------
+# Generate the mesh
+# ----------------------------------------------------------------------
+mesh volume all
+
+# ----------------------------------------------------------------------
+# Generate blocks and nodesets
+# ----------------------------------------------------------------------
+block 1 volume 1 3
+block 1 name "elastic"
+
+# ----------------------------------------------------------------------
+# Create nodeset for fault
+# ----------------------------------------------------------------------
+group "fault" add node in fault_surface
+nodeset 10 group fault
+nodeset 10 name "fault"
+
+# ----------------------------------------------------------------------
+# Create nodeset for BC
+# ----------------------------------------------------------------------
+group "surf_east" add node in surface 6
+nodeset 21 group surf_east
+nodeset 21 name "surf_east"
+
+group "surf_west" add node in surface 4
+nodeset 22 group surf_west
+nodeset 22 name "surf_west"
+
+group "surf_north" add node in surface 14
+group "surf_north" add node in surface 12
+group "surf_north" remove node in fault
+nodeset 23 group surf_north
+nodeset 23 name "surf_north"
+
+group "surf_south" add node in surface 17
+group "surf_south" add node in surface 10
+group "surf_south" remove node in fault
+nodeset 24 group surf_south
+nodeset 24 name "surf_south"
+
+group "surf_ground" add node in surface 16
+group "surf_ground" add node in surface 9
+nodeset 25 group surf_ground
+nodeset 25 name "surf_ground"
+
+group "surf_bottom" add node in surface 15
+group "surf_bottom" add node in surface 11
+nodeset 26 group surf_bottom
+nodeset 26 name "surf_bottom"
+
+# ----------------------------------------------------------------------
+# Export exodus file
+# ----------------------------------------------------------------------
+export mesh "volume_hex8.exo" dimension 3 overwrite



More information about the CIG-COMMITS mailing list