<div dir="ltr">Thanks Matt,<div><br></div><div>I changed your file to reproduce the error. If you run it on more than one processor you will get something similar to:</div><div><br></div><div><p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: --------------------- Error Message --------------------------------------------------------------</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: Invalid argument</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[</span><span style="background-color:rgb(224,102,102)">0]PETSC ERROR: Number of coordinates loaded 9 does not match number of vertices 13</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: See <a href="http://www.mcs.anl.gov/petsc/documentation/faq.html">http://www.mcs.anl.gov/petsc/documentation/faq.html</a> for trouble shooting.</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: Petsc Development GIT revision: v3.5.3-2186-g052b31f  GIT Date: 2015-03-04 11:15:59 -0600</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: /work/01624/amesga/Code/dmcomplex/ex5 on a sandybridge-cxx-dbg named <a href="http://c560-303.stampede.tacc.utexas.edu">c560-303.stampede.tacc.utexas.edu</a> by amesga Tue Mar 10 16:57:01 2015</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: Configure options --COPTFLAGS= --CXXOPTFLAGS= --FOPTFLAGS= --download-chaco=1 --download-exodusii=1 --download-hdf5=1 --download-metis=1 --download-netcdf=1 --download-parmetis=1 --with-blacs=1 --with-blas-lapack-dir=/opt/apps/intel/13/composer_xe_2013_sp1.1.106/mkl/lib/intel64 --with-clanguage=C++ --with-debugging=yes --with-hdf5=1 --with-metis=1 --with-valgrind=1 --download-triangle=1 --with-valgrind-dir=/opt/apps/valgrind/3.8.1/ --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel13/impi/<a href="http://4.1.3.049/intel64">4.1.3.049/intel64</a> --with-scalar-type=real --with-shared-libraries=1 --with-vendor-compilers=intel --with-x11=1 -with-pic PETSC_ARCH=sandybridge-cxx-dbg</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(224,102,102)">[0]PETSC ERROR: #1 DMPlexLoad_HDF5() line 741 in /work/01624/amesga/Software/petsc/src/dm/impls/plex/plexhdf5.c</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: #2 DMLoad_Plex() line 605 in /work/01624/amesga/Software/petsc/src/dm/impls/plex/plex.c</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: #3 DMLoad() line 2939 in /work/01624/amesga/Software/petsc/src/dm/interface/dm.c</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: #4 main() line 31 in /work/01624/amesga/Code/dmcomplex/ex5.c</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: No PETSc Option Table entries</span></p>
<p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)">[0]PETSC ERROR: ----------------End of Error Message -------</span></p><p style="margin:0px;font-family:Menlo"><span style="background-color:rgb(255,255,255)"><br></span></p><p style="margin:0px"><font face="arial, helvetica, sans-serif"><span style="background-color:rgb(255,255,255)">It seems like HDF5 version of DMView and DMLoad work fine for a serial DMPlex but </span>DMLoad<span style="background-color:rgb(255,255,255)"> breaks in parallel.</span></font></p><p style="margin:0px"><span style="background-color:rgb(255,255,255)"><font face="arial, helvetica, sans-serif"><br></font></span></p><p style="margin:0px"><span style="background-color:rgb(255,255,255)"><font face="arial, helvetica, sans-serif">Many thanks,</font></span></p><p style="margin:0px"><span style="background-color:rgb(255,255,255)"><font face="arial, helvetica, sans-serif">Ata</font></span></p></div><div class="gmail_extra"><br><div class="gmail_quote">On Tue, Mar 10, 2015 at 3:15 PM, Matthew Knepley <span dir="ltr"><<a href="mailto:knepley@gmail.com" target="_blank">knepley@gmail.com</a>></span> wrote:<br><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><div dir="ltr"><div class="gmail_extra"><div class="gmail_quote"><span class="">On Mon, Mar 9, 2015 at 11:28 AM, Ataollah Mesgarnejad <span dir="ltr"><<a href="mailto:amesga1@tigers.lsu.edu" target="_blank">amesga1@tigers.lsu.edu</a>></span> wrote:<br><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><div dir="ltr">Dear all,<div><br></div><div>I'm trying to save and load distributed DMPlex in HDF5 format with DMView and DMLoad. The problem is even though there are no errors while loading the DM when I look at the DM loaded from file is not equal to the DM that was saved. Also, when loading the DM if DMSetType is called before the DMLoad, DMLoad produces errors (like line <a href="https://bitbucket.org/petsc/petsc/src/236f5a4d227fe9d0affddb8701edb9509ad39525/src/snes/examples/tutorials/ex12.c?at=master#cl-316" target="_blank">316</a> in src/snes/examples/tutorials/ex12.c ).</div><div><br></div><div>I'm including a small code to replicate the problem here plus an input mesh file. <br></div></div></blockquote><div><br></div></span><div>Here is a simpler test, which I am going to make DMPlex ex5. The file you sent does not make sense</div><div>to me since it has cells with only two vertices. Run it with</div><div><br></div><div>  -dm_view ::ascii_info_detail</div><div><br></div><div>  Thanks,</div><div><br></div><div>    Matt</div><div><div class="h5"><div> </div><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><div dir="ltr"><div>Best,
</div><div>Ata</div><div><br></div><div><p style="margin:0px;font-family:Menlo;color:rgb(99,114,125)"><font size="1">/**</font></p><p style="margin:0px;font-family:Menlo;color:rgb(99,114,125)"><font size="1"> * @file</font></p><p style="margin:0px;font-family:Menlo;color:rgb(99,114,125)"><font size="1"> *</font></p><p style="margin:0px;font-family:Menlo;color:rgb(99,114,125)"><font size="1"> * Created by Ataollah Mesgarnejad on 3/6/15.</font></p><p style="margin:0px;font-family:Menlo;color:rgb(99,114,125)"><span style="font-size:x-small"> </span><span style="font-size:x-small">*</span><br></p><p style="margin:0px;font-family:Menlo;color:rgb(99,114,125)"><font size="1"> * This is a test to read and write a distributed DM.</font></p><p style="margin:0px;font-family:Menlo;color:rgb(99,114,125)"><font size="1"> *</font></p><p style="margin:0px;font-family:Menlo;color:rgb(99,114,125)"><font size="1"> */</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1"><br></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1"><br></font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(181,143,174)">static</span><span style="color:rgb(192,197,207)"> </span><span style="color:rgb(181,143,174)">char</span><span style="color:rgb(192,197,207)"> help[] = </span>"An example of the usage of PetscSF to scatter data back and forth between a \</font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1">a serial DM and its parallel counterpart.\n"<span style="color:rgb(192,197,207)">;</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1"><br></font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(150,181,180)">#include </span><petscdmplex.h></font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(150,181,180)">#include </span><petscsnes.h></font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(150,181,180)">#include </span><petscsf.h></font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(150,181,180)">#include </span><exodusII.h></font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1"><span style="color:rgb(150,181,180)">#include </span><span style="color:rgb(165,191,142)"><petsc-private/dmimpl.h></span><span style="color:rgb(150,181,180)">     </span>/*I      "petscdm.h"     I*/</font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(150,181,180)">#include </span><petscsf.h></font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(150,181,180)">#include </span><petscviewerhdf5.h></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1"><br></font></p><p style="margin:0px;font-family:Menlo;color:rgb(150,181,180)"><font size="1">#undef __FUNCT__</font></p><p style="margin:0px;font-family:Menlo;color:rgb(150,181,180)"><font size="1">#define __FUNCT__ <span style="color:rgb(165,191,142)">"main"</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1"><span style="color:rgb(181,143,174)">int</span> main(<span style="color:rgb(181,143,174)">int</span> argc,<span style="color:rgb(181,143,174)">char</span> **argv)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">{</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscErrorCode</span>      ierr;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">DM</span>                  dm, distDM,distDMold;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">char</span>                ifilename[<span style="color:rgb(150,181,180)">PETSC_MAX_PATH_LEN</span>];</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscBool</span>           flg;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">int</span>                 CPU_word_size = <span style="color:rgb(209,135,113)">0</span>,IO_word_size = <span style="color:rgb(209,135,113)">0</span>,exoid;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">float</span>               version;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscInt</span>            numproc,rank;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscViewer</span>         stdoutViewer,DMPlexHDF5View;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscReal</span>           *VArray;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscInt</span>            dim;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscInt</span>            numFields = <span style="color:rgb(209,135,113)">2</span>;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscInt</span>            numComp[<span style="color:rgb(209,135,113)">2</span>] = {<span style="color:rgb(209,135,113)">1</span>,<span style="color:rgb(209,135,113)">1</span>};</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscInt</span>            numDof[<span style="color:rgb(209,135,113)">6</span>] = {<span style="color:rgb(209,135,113)">1</span>, <span style="color:rgb(209,135,113)">0</span>, <span style="color:rgb(209,135,113)">0</span>,</font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1"><span style="color:rgb(192,197,207)">        </span><span style="color:rgb(209,135,113)">0</span><span style="color:rgb(192,197,207)">, </span><span style="color:rgb(209,135,113)">0</span><span style="color:rgb(192,197,207)">, </span><span style="color:rgb(209,135,113)">1</span><span style="color:rgb(192,197,207)">}; </span>/*{Vertex, Edge, Cell} */</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscInt</span>            bcFields[<span style="color:rgb(209,135,113)">1</span>] = {<span style="color:rgb(209,135,113)">0</span>}, numBC=<span style="color:rgb(209,135,113)">0</span>;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1"><span style="color:rgb(192,197,207)">    </span>//PetscInt          *remoteOffsets;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">char</span>**              namelist;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscInt</span>            off;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">IS</span>                  bcPoints[<span style="color:rgb(209,135,113)">1</span>] = {<span style="color:rgb(181,143,174)">NULL</span>};</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">IS</span>                  *ISlist;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscSection</span>        seqSection, distSection;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">Vec</span>                 distV, V;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscSF</span>             pointSF;<span style="color:rgb(79,90,102)">//,pointSFold;</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscInt</span>            pStart, pEnd, dof;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">PetscBool</span>           load_files = <span style="color:rgb(191,98,107)">PETSC_FALSE</span>, save_files = <span style="color:rgb(191,98,107)">PETSC_FALSE</span>;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(235,202,138)">MPI_Comm</span>            comm;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">PetscInitialize</span>(&argc, &argv, (<span style="color:rgb(181,143,174)">char</span>*)<span style="color:rgb(209,135,113)">0</span>, <span style="color:rgb(143,161,178)">help</span>);<span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">PetscViewerASCIIGetStdout</span>(<span style="color:rgb(150,181,180)">PETSC_COMM_SELF</span>,&stdoutViewer);<span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(235,202,138)"><font size="1"><span style="color:rgb(192,197,207)">    comm = </span>PETSC_COMM_WORLD<span style="color:rgb(192,197,207)">;</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1"><span style="color:rgb(192,197,207)">    </span>// PetscErrorCode DMCreateSubDM(DM dm, PetscInt numFields, PetscInt fields[], IS *is, DM *subdm)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(192,197,207)">    ierr = </span><span style="color:rgb(150,181,180)">PetscOptionsBegin</span><span style="color:rgb(192,197,207)">(</span><span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span><span style="color:rgb(192,197,207)">,</span>""<span style="color:rgb(192,197,207)">,</span>"PetscSF Test Options"<span style="color:rgb(192,197,207)">,</span>"none"<span style="color:rgb(192,197,207)">);</span><span style="color:rgb(150,181,180)">CHKERRQ</span><span style="color:rgb(192,197,207)">(ierr);</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(192,197,207)">    ierr = </span><span style="color:rgb(150,181,180)">PetscOptionsBool</span><span style="color:rgb(192,197,207)">(</span>"-save_files"<span style="color:rgb(192,197,207)">,</span>"save the distributed vector in HDF5 format"<span style="color:rgb(192,197,207)">,</span>""<span style="color:rgb(192,197,207)">,</span><span style="color:rgb(191,98,107)">PETSC_FALSE</span><span style="color:rgb(192,197,207)">,&save_files,</span><span style="color:rgb(181,143,174)">NULL</span><span style="color:rgb(192,197,207)">);</span><span style="color:rgb(150,181,180)">CHKERRQ</span><span style="color:rgb(192,197,207)">(ierr);</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(192,197,207)">    ierr = </span><span style="color:rgb(150,181,180)">PetscOptionsBool</span><span style="color:rgb(192,197,207)">(</span>"-load_files"<span style="color:rgb(192,197,207)">,</span>"Load the distributed vector in HDF5 format"<span style="color:rgb(192,197,207)">,</span>""<span style="color:rgb(192,197,207)">,</span><span style="color:rgb(191,98,107)">PETSC_FALSE</span><span style="color:rgb(192,197,207)">,&load_files,</span><span style="color:rgb(181,143,174)">NULL</span><span style="color:rgb(192,197,207)">);</span><span style="color:rgb(150,181,180)">CHKERRQ</span><span style="color:rgb(192,197,207)">(ierr);</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(150,181,180)"><font size="1"><span style="color:rgb(192,197,207)">    ierr = </span>PetscOptionsEnd<span style="color:rgb(192,197,207)">();</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">PetscOptionsGetString</span>(<span style="color:rgb(150,181,180)">PETSC_NULL</span>,<span style="color:rgb(165,191,142)">"-i"</span>,ifilename,<span style="color:rgb(181,143,174)">sizeof</span> ifilename,&flg);<span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">MPI_Comm_size</span>(<span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span>,&numproc);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">MPI_Comm_rank</span>(<span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span>,&rank);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">if</span> (!rank)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    {</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        exoid = <span style="color:rgb(150,181,180)">ex_open</span>(ifilename,<span style="color:rgb(150,181,180)">EX_READ</span>,&CPU_word_size,&IO_word_size,&version);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(192,197,207)">        </span><span style="color:rgb(181,143,174)">if</span><span style="color:rgb(192,197,207)"> (exoid <= </span><span style="color:rgb(209,135,113)">0</span><span style="color:rgb(192,197,207)">) </span><span style="color:rgb(150,181,180)">SETERRQ1</span><span style="color:rgb(192,197,207)">(</span><span style="color:rgb(150,181,180)">PETSC_COMM_SELF</span><span style="color:rgb(192,197,207)">,</span><span style="color:rgb(150,181,180)">PETSC_ERR_LIB</span><span style="color:rgb(192,197,207)">,</span>"ex_open(\"%s\",...) did not return a valid file ID"<span style="color:rgb(192,197,207)">,ifilename);</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    }</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">else</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    {</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        exoid = -<span style="color:rgb(209,135,113)">1</span>;                 <span style="color:rgb(79,90,102)">/* Not used */</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    }</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMPlexCreateExodus</span>(<span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span>,exoid,<span style="color:rgb(191,98,107)">PETSC_FALSE</span>,&dm);                                                  <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">PetscObjectSetName</span>((<span style="color:rgb(235,202,138)">PetscObject</span>) dm,<span style="color:rgb(165,191,142)">"sequential-DM"</span>);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMGetDimension</span>(dm, &dim);                                                                                    <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">if</span> (numproc < <span style="color:rgb(209,135,113)">2</span> ) distDM = dm;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">else</span> ierr = <span style="color:rgb(191,98,107)">DMPlexDistribute</span>(dm, <span style="color:rgb(209,135,113)">0</span>, &pointSF, &distDM);                                                             <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">PetscObjectSetName</span>((<span style="color:rgb(235,202,138)">PetscObject</span>) distDM,<span style="color:rgb(165,191,142)">"Distributed-DM"</span>);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1"><br></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMPlexCreateSection</span>(dm,      dim, numFields, numComp, numDof,</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">                               numBC, bcFields, bcPoints,<span style="color:rgb(150,181,180)">PETSC_NULL</span>, &seqSection);                                      <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMPlexCreateSection</span>(distDM,  dim, numFields, numComp, numDof,</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">                               numBC, bcFields, bcPoints,<span style="color:rgb(150,181,180)">PETSC_NULL</span>, &distSection);                                     <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMSetDefaultSection</span>(dm, seqSection);                                                                         <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMSetDefaultSection</span>(distDM, distSection);                                                                    <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMCreateGlobalVector</span>(dm, &V);                                                                                <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">VecCreate</span>(comm, &distV);                                                                                     <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">PetscObjectSetName</span>((<span style="color:rgb(235,202,138)">PetscObject</span>) distV,<span style="color:rgb(165,191,142)">"Distributed-V"</span>);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1"><br></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">VecGetArray</span>(V, &VArray);                                                                                     <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1"><span style="color:rgb(192,197,207)">    </span>// fill vertex data</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMPlexGetDepthStratum</span>(dm, <span style="color:rgb(209,135,113)">0</span>, &pStart, &pEnd);                                                                <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">for</span> (<span style="color:rgb(181,143,174)">int</span> p = pStart; p < pEnd; p++)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    {</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">PetscSectionGetDof</span>(seqSection, p, &dof);                                                                 <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">PetscSectionGetOffset</span>(seqSection, p, &off);                                                              <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        <span style="color:rgb(181,143,174)">for</span> (<span style="color:rgb(181,143,174)">int</span> d = <span style="color:rgb(209,135,113)">0</span>; d < dof; d++)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        {</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">            VArray[off + d] = p;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        }</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    }</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1"><span style="color:rgb(192,197,207)">    </span>// fill cell data</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMPlexGetDepthStratum</span>(dm, <span style="color:rgb(209,135,113)">1</span>, &pStart, &pEnd);                                                                <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">for</span> (<span style="color:rgb(181,143,174)">int</span> p = pStart; p < pEnd; p++)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    {</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">PetscSectionGetDof</span>(seqSection, p, &dof);                                                                 <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">PetscSectionGetOffset</span>(seqSection, p, &off);                                                              <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        <span style="color:rgb(181,143,174)">for</span> (<span style="color:rgb(181,143,174)">int</span> d = <span style="color:rgb(209,135,113)">0</span>; d < dof; d++)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        {</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">            VArray[off + d] = -p-<span style="color:rgb(209,135,113)">1</span>;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        }</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    }</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">VecRestoreArray</span>(V, &VArray); <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMCreateFieldIS</span>(dm, &numFields, &namelist, &ISlist);                                                         <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMPlexDistributeField</span>(dm, pointSF, seqSection, V, distSection, distV);                                       <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(150,181,180)"><font size="1">#if defined(PETSC_HAVE_HDF5)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">if</span> (save_files)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    {</font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1"><span style="color:rgb(192,197,207)">        </span>// distribute fields</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">        </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">PetscPrintf</span>(<span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span>, <span style="color:rgb(165,191,142)">"==== Distrubuted DM\n"</span>);                                                  <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">DMView</span>(distDM, <span style="color:rgb(150,181,180)">PETSC_VIEWER_STDOUT_WORLD</span>);                                                               <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(235,202,138)"><font size="1"><span style="color:rgb(192,197,207)">        </span><span style="color:rgb(191,98,107)">PetscSynchronizedFlush</span><span style="color:rgb(192,197,207)">(</span>PETSC_COMM_WORLD<span style="color:rgb(192,197,207)">, </span>PETSC_STDOUT<span style="color:rgb(192,197,207)">); </span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1"><span style="color:rgb(192,197,207)">        </span>// Save distributed data</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">        </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">PetscViewerHDF5Open</span>(<span style="color:rgb(191,98,107)">PetscObjectComm</span>((<span style="color:rgb(235,202,138)">PetscObject</span>) distDM),<span style="color:rgb(165,191,142)">"distDM.h5"</span>, <span style="color:rgb(191,98,107)">FILE_MODE_WRITE</span>, &DMPlexHDF5View);<span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(192,197,207)">        ierr = </span><span style="color:rgb(191,98,107)">PetscPrintf</span><span style="color:rgb(192,197,207)">(</span><span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span><span style="color:rgb(192,197,207)">,</span>"Writing dist DM ...\n"<span style="color:rgb(192,197,207)">);</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(235,202,138)"><font size="1"><span style="color:rgb(192,197,207)">        </span><span style="color:rgb(191,98,107)">PetscSynchronizedFlush</span><span style="color:rgb(192,197,207)">(</span>PETSC_COMM_WORLD<span style="color:rgb(192,197,207)">, </span>PETSC_STDOUT<span style="color:rgb(192,197,207)">);</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">DMView</span>(distDM, DMPlexHDF5View);                                                                          <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">         </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        <span style="color:rgb(191,98,107)">PetscViewerDestroy</span>(&DMPlexHDF5View);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">        </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    }</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">else</span> <span style="color:rgb(181,143,174)">if</span> (load_files)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    {</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">PetscPrintf</span>(<span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span>,<span style="color:rgb(165,191,142)">"Loading dist vectors ...\n"</span>);                                              <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">PetscViewerHDF5Open</span>(<span style="color:rgb(150,181,180)">PETSC_COMM_SELF</span>,<span style="color:rgb(165,191,142)">"distDM.h5"</span>, <span style="color:rgb(191,98,107)">FILE_MODE_READ</span>, &DMPlexHDF5View);                       <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">DMCreate</span>(comm,&distDMold);                                                                               <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">        </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">DMLoad</span>(distDMold,DMPlexHDF5View);                                                                        <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">DMSetType</span>(distDMold, <span style="color:rgb(150,181,180)">DMPLEX</span>);                                                                            <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1"><span style="color:rgb(192,197,207)">        </span>/*ierr = DMPlexCreateSection(distDMold,  dim, numFields, numComp, numDof,</font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1">                                   numBC, bcFields, bcPoints,PETSC_NULL, &distSectionold);                              CHKERRQ(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1">        ierr = DMSetDefaultSection(distDMold, distSectionold);CHKERRQ(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1">        ierr = DMGetPointSF(distDMold,&pointSFold);                                                                     CHKERRQ(ierr);*/</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        <span style="color:rgb(191,98,107)">PetscViewerDestroy</span>(&DMPlexHDF5View);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">PetscPrintf</span>(<span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span>, <span style="color:rgb(165,191,142)">"==== Read DM\n"</span>);                                                         <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        ierr = <span style="color:rgb(191,98,107)">DMView</span>(distDMold, <span style="color:rgb(150,181,180)">PETSC_VIEWER_STDOUT_WORLD</span>);                                                            <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        <span style="color:rgb(191,98,107)">PetscSynchronizedFlush</span>(<span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span>, <span style="color:rgb(235,202,138)">PETSC_STDOUT</span>);                                                         <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        <span style="color:rgb(191,98,107)">DMPlexEqual</span>(distDM, distDMold, &flg);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        <span style="color:rgb(181,143,174)">if</span> (flg)</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        {</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">            <span style="color:rgb(191,98,107)">PetscPrintf</span>(<span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span>,<span style="color:rgb(165,191,142)">"\n DMs equal\n"</span>);      </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        }</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        <span style="color:rgb(181,143,174)">else</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        {</font></p><p style="margin:0px;font-family:Menlo;color:rgb(165,191,142)"><font size="1"><span style="color:rgb(192,197,207)">            </span><span style="color:rgb(191,98,107)">PetscPrintf</span><span style="color:rgb(192,197,207)">(</span><span style="color:rgb(235,202,138)">PETSC_COMM_WORLD</span><span style="color:rgb(192,197,207)">,</span>"\n DMs are not equal\n\n"<span style="color:rgb(192,197,207)">);</span></font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">        }</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    }</font></p><p style="margin:0px;font-family:Menlo;color:rgb(150,181,180)"><font size="1">#endif</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">VecDestroy</span>(&V); <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">VecDestroy</span>(&distV); <span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(79,90,102)"><font size="1"><span style="color:rgb(192,197,207)">    </span>//ierr = VecDestroy(&seqV); CHKERRQ(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMDestroy</span>(&dm);<span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">DMDestroy</span>(&distDM);<span style="color:rgb(150,181,180)">CHKERRQ</span>(ierr);</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207);min-height:21px"><font size="1">    </font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    ierr = <span style="color:rgb(191,98,107)">PetscFinalize</span>();</font></p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">    <span style="color:rgb(181,143,174)">return</span> <span style="color:rgb(209,135,113)">0</span>;</font></p><p style="margin:0px;font-family:Menlo;color:rgb(99,114,125)">




















































































































































































</p><p style="margin:0px;font-family:Menlo;color:rgb(192,197,207)"><font size="1">}</font></p></div><div><br></div><div><br></div></div>
</blockquote></div></div></div><span class="HOEnZb"><font color="#888888"><br><br clear="all"><div><br></div>-- <br><div>What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead.<br>-- Norbert Wiener</div>
</font></span></div></div>
</blockquote></div><div class="gmail_signature"><div dir="ltr"><div dir="ltr"><div dir="ltr"><br></div></div></div></div>
</div></div>