]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Fix a number of problems where we didn't follow our coding standards. Remove one...
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 1 Sep 2006 17:05:59 +0000 (17:05 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 1 Sep 2006 17:05:59 +0000 (17:05 +0000)
git-svn-id: https://svn.dealii.org/trunk@13787 0785d39b-7218-0410-832d-ea1e28bc413d

16 files changed:
deal.II/deal.II/include/fe/fe_dgp.h
deal.II/deal.II/include/fe/fe_dgp_monomial.h
deal.II/deal.II/include/fe/fe_dgp_nonparametric.h
deal.II/deal.II/include/fe/fe_dgq.h
deal.II/deal.II/include/fe/fe_poly_tensor.h
deal.II/deal.II/include/grid/grid_reordering_internal.h
deal.II/deal.II/include/grid/tria.h
deal.II/deal.II/include/multigrid/mg_base.h
deal.II/deal.II/include/multigrid/mg_matrix.h
deal.II/deal.II/include/multigrid/mg_smoother.h
deal.II/deal.II/include/multigrid/multigrid.h
deal.II/deal.II/include/multigrid/multigrid.templates.h
deal.II/deal.II/source/fe/fe_dgp_monomial.cc
deal.II/deal.II/source/fe/fe_dgp_nonparametric.cc
deal.II/deal.II/source/fe/fe_dgq.cc
deal.II/deal.II/source/grid/grid_reordering.cc

index 6c863c40322c6dde1ac12260e12f47f610175561..a1ffce4ac8343c7337ccbe8eb109c446bc2397cf 100644 (file)
@@ -246,7 +246,7 @@ class FE_DGP : public FE_Poly<PolynomialSpace<dim>,dim>
                                      * be passed to the constructor of
                                      * @p FiniteElementData.
                                      */
-    static std::vector<unsigned int> get_dpo_vector(unsigned int degree);
+    static std::vector<unsigned int> get_dpo_vector (const unsigned int degree);
 };
 
 /* @} */
index 8a0774f27adbd9d51d821f1ceaf5c8dcab7ee24a..9210b66e85b07cae76baf2627bda9af6d79e67df 100644 (file)
@@ -239,7 +239,7 @@ class FE_DGPMonomial : public FE_Poly<PolynomialsP<dim>,dim>
                                      * be passed to the constructor of
                                      * @p FiniteElementData.
                                      */
-    static std::vector<unsigned int> get_dpo_vector(unsigned int degree);
+    static std::vector<unsigned int> get_dpo_vector (const unsigned int degree);
 
                                     /**
                                      * Initialize the embedding
index 30f6c6727f0cc6887582b7aa6721f692ac287006..2c85dbd6d9f7c5489677efe54557e5ccf6c10050 100644 (file)
@@ -424,7 +424,7 @@ class FE_DGPNonparametric : public FiniteElement<dim>
                                      * be passed to the constructor of
                                      * @p FiniteElementData.
                                      */
-    static std::vector<unsigned int> get_dpo_vector(unsigned int degree);
+    static std::vector<unsigned int> get_dpo_vector (const unsigned int degree);
     
                                     /**
                                      * Given a set of flags indicating
index 2f3f252dc2216d00621cd69317901dec6037fdf3..57f9e5b6eedd8a6d137ad1e863086b1e9fb3c70c 100644 (file)
@@ -239,7 +239,7 @@ class FE_DGQ : public FE_Poly<TensorProductPolynomials<dim>,dim>
                                      * be passed to the constructor of
                                      * @p FiniteElementData.
                                      */
-    static std::vector<unsigned int> get_dpo_vector(unsigned int degree);
+    static std::vector<unsigned int> get_dpo_vector (const unsigned int degree);
   
                                     /**
                                      * Compute renumbering for rotation
index efd05294a1b75f96782b47c3afc517f95857d33f..787ae1a97657d474fc921e2c4a726dfbd6f9ed11 100644 (file)
@@ -120,7 +120,7 @@ class FE_PolyTensor : public FiniteElement<dim>
                                      * different from @p
                                      * fe_data.degree.
                                      */
-    FE_PolyTensor (unsigned int degree,
+    FE_PolyTensor (const unsigned int degree,
                   const FiniteElementData<dim> &fe_data,
                   const std::vector<bool> &restriction_is_additive_flags,
                   const std::vector<std::vector<bool> > &nonzero_components);
index 79db53aceb25da9a37a3a15f1452fe939e8736da..6c69b7b6b054efbdddd99b2f0a5411ef91f4bd33 100644 (file)
@@ -360,16 +360,6 @@ namespace internal
                                          */
        bool side_hop (unsigned int &qnum,
                       unsigned int &lsn) const;
-  
-                                        /**
-                                         * Sets lsn so that it points
-                                         * to the opposite side of
-                                         * the current quad (qnum)
-                                         * that it was originally
-                                         * pointing to.
-                                         */
-       bool switch_faces (unsigned int &qnum,
-                          unsigned int &lsn) const;
 
                                         /**
                                          * A list of enriched
index d3725559d39cc6474e0b740e23d0154ae7bb1714..033a1430d39d1af07bc967e7001cb23a63f6bf75 100644 (file)
@@ -2659,7 +2659,7 @@ class Triangulation : public Subscriptor
                                      * Return @p true if the vertex
                                      * with this @p index is used.
                                      */
-    bool vertex_used (unsigned int index) const;
+    bool vertex_used (const unsigned int index) const;
     
                                     /**
                                      * Return a constant reference to
index c6366cd46e1326f043ec849660ea50fd75e91889..89ba51aae3acd3cb3c33eb8ad40119158fa022f4 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -51,31 +51,35 @@ class MGMatrixBase : public Subscriptor
                                    * Matrix-vector-multiplication on
                                    * a certain level.
                                    */
-  virtual void vmult(unsigned int level, VECTOR& dst,
-                    const VECTOR& src) const = 0;
+  virtual void vmult (const unsigned int level,
+                     VECTOR& dst,
+                     const VECTOR& src) const = 0;
 
                                   /**
                                    * Adding matrix-vector-multiplication on
                                    * a certain level.
                                    */
-  virtual void vmult_add(unsigned int level, VECTOR& dst,
-                    const VECTOR& src) const = 0;
+  virtual void vmult_add (const unsigned int level,
+                         VECTOR& dst,
+                         const VECTOR& src) const = 0;
 
                                   /**
                                    * Transpose
                                    * matrix-vector-multiplication on
                                    * a certain level.
                                    */
-  virtual void Tvmult(unsigned int level, VECTOR& dst,
-                    const VECTOR& src) const = 0;
+  virtual void Tvmult (const unsigned int level,
+                      VECTOR& dst,
+                      const VECTOR& src) const = 0;
 
                                   /**
                                    * Adding transpose
                                    * matrix-vector-multiplication on
                                    * a certain level.
                                    */
-  virtual void Tvmult_add(unsigned int level, VECTOR& dst,
-                    const VECTOR& src) const = 0;
+  virtual void Tvmult_add (const unsigned int level,
+                          VECTOR& dst,
+                          const VECTOR& src) const = 0;
 };
 
 
index 441ccc11c0b790f794e6d67fbd25c176e1b511f0..7033be170170da95a9e6b9a80907e6cd000ed92f 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -55,31 +55,35 @@ class MGMatrix : public MGMatrixBase<VECTOR>
                                      * Matrix-vector-multiplication on
                                      * a certain level.
                                      */
-    virtual void vmult(unsigned int level, VECTOR& dst,
-                      const VECTOR& src) const;
+    virtual void vmult (const unsigned int level,
+                       VECTOR& dst,
+                       const VECTOR& src) const;
     
-                                  /**
-                                   * Adding matrix-vector-multiplication on
-                                   * a certain level.
-                                   */
-  virtual void vmult_add(unsigned int level, VECTOR& dst,
-                    const VECTOR& src) const;
-
-                                  /**
-                                   * Transpose
-                                   * matrix-vector-multiplication on
-                                   * a certain level.
-                                   */
-  virtual void Tvmult(unsigned int level, VECTOR& dst,
-                    const VECTOR& src) const;
-
-                                  /**
-                                   * Adding transpose
-                                   * matrix-vector-multiplication on
-                                   * a certain level.
-                                   */
-  virtual void Tvmult_add(unsigned int level, VECTOR& dst,
-                    const VECTOR& src) const;
+                                    /**
+                                     * Adding matrix-vector-multiplication on
+                                     * a certain level.
+                                     */
+    virtual void vmult_add (const unsigned int level,
+                           VECTOR& dst,
+                           const VECTOR& src) const;
+
+                                    /**
+                                     * Transpose
+                                     * matrix-vector-multiplication on
+                                     * a certain level.
+                                     */
+    virtual void Tvmult (const unsigned int level,
+                        VECTOR& dst,
+                        const VECTOR& src) const;
+
+                                    /**
+                                     * Adding transpose
+                                     * matrix-vector-multiplication on
+                                     * a certain level.
+                                     */
+    virtual void Tvmult_add (const unsigned int level,
+                            VECTOR& dst,
+                            const VECTOR& src) const;
     
                                     /**
                                      * Memory used by this object.
@@ -87,11 +91,11 @@ class MGMatrix : public MGMatrixBase<VECTOR>
     unsigned int memory_consumption () const;
     
 
-private:
-  /**
-   * Pointer to the matrix objects on each level.
-   */
-  SmartPointer<MGLevelObject<MATRIX> > matrix;
+  private:
+                                    /**
+                                     * Pointer to the matrix objects on each level.
+                                     */
+    SmartPointer<MGLevelObject<MATRIX> > matrix;
 };
 
 
@@ -141,37 +145,41 @@ class MGMatrixSelect : public MGMatrixBase<Vector<number> >
                                      * Matrix-vector-multiplication on
                                      * a certain level.
                                      */
-    virtual void vmult(unsigned int level, Vector<number>& dst,
-                      const Vector<number>& src) const;
+    virtual void vmult (const unsigned int level,
+                       Vector<number>& dst,
+                       const Vector<number>& src) const;
     
-                                  /**
-                                   * Adding matrix-vector-multiplication on
-                                   * a certain level.
-                                   */
-  virtual void vmult_add(unsigned int level, Vector<number>& dst,
+                                    /**
+                                     * Adding matrix-vector-multiplication on
+                                     * a certain level.
+                                     */
+    virtual void vmult_add (const unsigned int level,
+                           Vector<number>& dst,
+                           const Vector<number>& src) const;
+
+                                    /**
+                                     * Transpose
+                                     * matrix-vector-multiplication on
+                                     * a certain level.
+                                     */
+    virtual void Tvmult (const unsigned int level,
+                        Vector<number>& dst,
                         const Vector<number>& src) const;
 
-                                  /**
-                                   * Transpose
-                                   * matrix-vector-multiplication on
-                                   * a certain level.
-                                   */
-  virtual void Tvmult(unsigned int level, Vector<number>& dst,
-                     const Vector<number>& src) const;
-
-                                  /**
-                                   * Adding transpose
-                                   * matrix-vector-multiplication on
-                                   * a certain level.
-                                   */
-  virtual void Tvmult_add(unsigned int level, Vector<number>& dst,
-                         const Vector<number>& src) const;    
+                                    /**
+                                     * Adding transpose
+                                     * matrix-vector-multiplication on
+                                     * a certain level.
+                                     */
+    virtual void Tvmult_add (const unsigned int level,
+                            Vector<number>& dst,
+                            const Vector<number>& src) const;    
 
   private:
-  /**
-   * Pointer to the matrix objects on each level.
-   */
-  SmartPointer<MGLevelObject<MATRIX> > matrix;
+                                    /**
+                                     * Pointer to the matrix objects on each level.
+                                     */
+    SmartPointer<MGLevelObject<MATRIX> > matrix;
                                     /**
                                      * Row coordinate of selected block.
                                      */
@@ -204,9 +212,9 @@ MGMatrix<MATRIX, VECTOR>::set_matrix (MGLevelObject<MATRIX>* p)
 
 template <class MATRIX, class VECTOR>
 void
-MGMatrix<MATRIX, VECTOR>::vmult (unsigned int level,
-                                VECTOR& dst,
-                                const VECTOR& src) const
+MGMatrix<MATRIX, VECTOR>::vmult  (const unsigned int level,
+                                 VECTOR& dst,
+                                 const VECTOR& src) const
 {
   Assert(matrix != 0, ExcNotInitialized());
   
@@ -217,9 +225,9 @@ MGMatrix<MATRIX, VECTOR>::vmult (unsigned int level,
 
 template <class MATRIX, class VECTOR>
 void
-MGMatrix<MATRIX, VECTOR>::vmult_add (unsigned int level,
-                                VECTOR& dst,
-                                const VECTOR& src) const
+MGMatrix<MATRIX, VECTOR>::vmult_add  (const unsigned int level,
+                                     VECTOR& dst,
+                                     const VECTOR& src) const
 {
   Assert(matrix != 0, ExcNotInitialized());
   
@@ -230,9 +238,9 @@ MGMatrix<MATRIX, VECTOR>::vmult_add (unsigned int level,
 
 template <class MATRIX, class VECTOR>
 void
-MGMatrix<MATRIX, VECTOR>::Tvmult (unsigned int level,
-                                VECTOR& dst,
-                                const VECTOR& src) const
+MGMatrix<MATRIX, VECTOR>::Tvmult  (const unsigned int level,
+                                  VECTOR& dst,
+                                  const VECTOR& src) const
 {
   Assert(matrix != 0, ExcNotInitialized());
   
@@ -243,9 +251,9 @@ MGMatrix<MATRIX, VECTOR>::Tvmult (unsigned int level,
 
 template <class MATRIX, class VECTOR>
 void
-MGMatrix<MATRIX, VECTOR>::Tvmult_add (unsigned int level,
-                                VECTOR& dst,
-                                const VECTOR& src) const
+MGMatrix<MATRIX, VECTOR>::Tvmult_add  (const unsigned int level,
+                                      VECTOR& dst,
+                                      const VECTOR& src) const
 {
   Assert(matrix != 0, ExcNotInitialized());
   
@@ -268,10 +276,10 @@ MGMatrixSelect<MATRIX, number>::
 MGMatrixSelect (const unsigned int row,
                const unsigned int col,
                MGLevelObject<MATRIX>* p)
-  :
-  matrix (p, typeid(*this).name()),
-  row(row),
-  col(col)
+               :
+               matrix (p, typeid(*this).name()),
+               row(row),
+               col(col)
 {}
 
 
@@ -298,9 +306,9 @@ select_block (const unsigned int brow,
 template <class MATRIX, typename number>
 void
 MGMatrixSelect<MATRIX, number>::
-vmult (unsigned int level,
-       Vector<number>& dst,
-       const Vector<number>& src) const
+vmult  (const unsigned int level,
+       Vector<number>& dst,
+       const Vector<number>& src) const
 {
   Assert(matrix != 0, ExcNotInitialized());
   
@@ -312,9 +320,9 @@ vmult (unsigned int level,
 template <class MATRIX, typename number>
 void
 MGMatrixSelect<MATRIX, number>::
-vmult_add (unsigned int level,
-          Vector<number>& dst,
-          const Vector<number>& src) const
+vmult_add  (const unsigned int level,
+           Vector<number>& dst,
+           const Vector<number>& src) const
 {
   Assert(matrix != 0, ExcNotInitialized());
   
@@ -326,9 +334,9 @@ vmult_add (unsigned int level,
 template <class MATRIX, typename number>
 void
 MGMatrixSelect<MATRIX, number>::
-Tvmult (unsigned int level,
-       Vector<number>& dst,
-       const Vector<number>& src) const
+Tvmult  (const unsigned int level,
+        Vector<number>& dst,
+        const Vector<number>& src) const
 {
   Assert(matrix != 0, ExcNotInitialized());
   
@@ -340,9 +348,9 @@ Tvmult (unsigned int level,
 template <class MATRIX, typename number>
 void
 MGMatrixSelect<MATRIX, number>::
-Tvmult_add (unsigned int level,
-           Vector<number>& dst,
-           const Vector<number>& src) const
+Tvmult_add  (const unsigned int level,
+            Vector<number>& dst,
+            const Vector<number>& src) const
 {
   Assert(matrix != 0, ExcNotInitialized());
   
index c1c4f112e525590b3653ca141eeb0b135d3450a4..0af2635caad5c3b6210563c3dfda8dff172ea267 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -140,7 +140,7 @@ class MGSmootherContinuous : public MGSmootherBase<VECTOR>
                                     /**
                                      * Modify the number of smoothing steps.
                                      */
-    void set_steps(unsigned int steps);
+    void set_steps (const unsigned int steps);
     
                                     /**
                                      * How many steps should be used?
@@ -387,7 +387,7 @@ MGSmootherIdentity<VECTOR>::smooth (
 template <class VECTOR>
 inline
 void
-MGSmootherContinuous<VECTOR>::set_steps(unsigned int i)
+MGSmootherContinuous<VECTOR>::set_steps (const unsigned int i)
 {
   steps = i;
 }
index ed612cd6e08ecd449b844683dea936ffef2c5882..6ddb8b22276d9b82ad37380cf5c63bd88278b557 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -250,7 +250,7 @@ class Multigrid : public Subscriptor
                                      * smaller than the current
                                      * #minlevel.
                                      */
-    void set_maxlevel(unsigned int);
+    void set_maxlevel (const unsigned int);
 
                                     /**
                                      * Set the coarse level for which
@@ -277,8 +277,8 @@ class Multigrid : public Subscriptor
                                      * to adjust your coarse grid
                                      * solver!
                                      */
-    void set_minlevel(unsigned int level,
-                     bool relative = false);
+    void set_minlevel (const unsigned int level,
+                      bool relative = false);
 
                                     /**
                                      * Chance #cycle_type used in cycle().
@@ -291,7 +291,7 @@ class Multigrid : public Subscriptor
                                      * debugging output during the
                                      * multigrid cycles.
                                      */
-    void set_debug(unsigned int);
+    void set_debug (const unsigned int);
     
   private:
     
index 81fc1df3279b0e1cd28b551689c5614c4d8175f4..0db7beffdcdc464aff152f54a80c97becbd5a78d 100644 (file)
@@ -69,7 +69,7 @@ Multigrid<VECTOR>::reinit(const unsigned int min_level,
 
 template <class VECTOR>
 void
-Multigrid<VECTOR>::set_maxlevel(unsigned int l)
+Multigrid<VECTOR>::set_maxlevel (const unsigned int l)
 {
   Assert (l <= maxlevel, ExcIndexRange(l,minlevel,maxlevel+1));
   Assert (l >= minlevel, ExcIndexRange(l,minlevel,maxlevel+1));
@@ -79,8 +79,8 @@ Multigrid<VECTOR>::set_maxlevel(unsigned int l)
 
 template <class VECTOR>
 void
-Multigrid<VECTOR>::set_minlevel(unsigned int l,
-                               bool relative)
+Multigrid<VECTOR>::set_minlevel (const unsigned int l,
+                                const bool relative)
 {
   Assert (l <= maxlevel, ExcIndexRange(l,minlevel,maxlevel+1));
   minlevel = (relative)
@@ -99,7 +99,7 @@ Multigrid<VECTOR>::set_cycle(typename Multigrid<VECTOR>::Cycle c)
 
 template <class VECTOR>
 void
-Multigrid<VECTOR>::set_debug(unsigned int d)
+Multigrid<VECTOR>::set_debug (const unsigned int d)
 {
   debug = d;
 }
index 55c267f9352f1c8525fe4e80bb3ad2f31c1ff88d..358542579151baa1b3bd1d2579402b926c281bb7 100644 (file)
@@ -237,13 +237,13 @@ FE_DGPMonomial<dim>::initialize_restriction ()
 
 template <int dim>
 std::vector<unsigned int>
-FE_DGPMonomial<dim>::get_dpo_vector(unsigned int deg)
+FE_DGPMonomial<dim>::get_dpo_vector (const unsigned int deg)
 {
   std::vector<unsigned int> dpo(dim+1, 0U);
-  dpo[dim] = ++deg;
+  dpo[dim] = deg+1;
   for (unsigned int i=1;i<dim;++i)
     {
-      dpo[dim] *= deg+i;
+      dpo[dim] *= deg+1+i;
       dpo[dim] /= i+1;
     }
   return dpo;
index f1bc7cc882e42bcdd7f148264cba42c86cc0c6dd..584121ae3547b5f91e9c9e9e0d57505415d685d5 100644 (file)
@@ -179,13 +179,13 @@ FE_DGPNonparametric<dim>::shape_grad_grad_component (const unsigned int i,
 
 template <int dim>
 std::vector<unsigned int>
-FE_DGPNonparametric<dim>::get_dpo_vector(unsigned int deg)
+FE_DGPNonparametric<dim>::get_dpo_vector (const unsigned int deg)
 {
   std::vector<unsigned int> dpo(dim+1, static_cast<unsigned int>(0));
-  dpo[dim] = ++deg;
+  dpo[dim] = deg+1;
   for (unsigned int i=1;i<dim;++i)
     {
-      dpo[dim] *= deg+i;
+      dpo[dim] *= deg+1+i;
       dpo[dim] /= i+1;
     }
   return dpo;
index 05a9d8929ba7e415024043d501ee063bbc6a2cf5..4ee84cd34ba9c26d3b1b78345b37640f4f756467 100644 (file)
@@ -252,12 +252,12 @@ FE_DGQ<dim>::clone() const
 
 template <int dim>
 std::vector<unsigned int>
-FE_DGQ<dim>::get_dpo_vector(unsigned int deg)
+FE_DGQ<dim>::get_dpo_vector (const unsigned int deg)
 {
   std::vector<unsigned int> dpo(dim+1, 0U);
-  dpo[dim] = ++deg;
+  dpo[dim] = deg+1;
   for (unsigned int i=1;i<dim;++i)
-    dpo[dim] *= deg;
+    dpo[dim] *= deg+1;
   return dpo;
 }
 
index 33c137c9be54c2046bb97eef542919a5d225ab9d..1ffc1ca3e98a0a888331cfb8c155e1cead3ce651 100644 (file)
@@ -2,7 +2,7 @@
 //   grid_reordering.cc,v 1.27 2002/05/28 07:43:22 wolf Exp
 //   Version: 
 //
-//   Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+//   Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
 //
 //   This file is subject to QPL and may not be  distributed
 //   without copyright and license information. Please refer
@@ -368,14 +368,14 @@ namespace internal
                                       // do what the comment in the
                                       // class declaration says
       unsigned int qnum = 0;
-      while(get_unoriented_quad(qnum))
+      while (get_unoriented_quad(qnum))
        {
          unsigned int lsn = 0;
-         while(get_unoriented_side(qnum,lsn))
+         while (get_unoriented_side(qnum,lsn))
            {
              orient_side(qnum,lsn);
              unsigned int qqnum = qnum;
-             while(side_hop(qqnum,lsn))
+             while (side_hop(qqnum,lsn))
                {
                                                   // switch this face
                  lsn = (lsn+2)%4;

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.