]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Rename functions to avoid confusing them with assertions.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 20 Sep 2006 16:38:18 +0000 (16:38 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 20 Sep 2006 16:38:18 +0000 (16:38 +0000)
git-svn-id: https://svn.dealii.org/trunk@13934 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/source/dofs/dof_tools.cc
deal.II/deal.II/source/dofs/hp_dof_handler.cc

index 6a377b4dbbead479206c146fd912835a4ff3e7e4..ddeca6a7736c86375f4c1a8d5dbfdc65a8b985a0 100644 (file)
@@ -1573,7 +1573,7 @@ namespace internal
                                         */
       template <int dim>
       void
-      assert_existence_of_face_matrix (const FiniteElement<dim> &fe1,
+      ensure_existence_of_face_matrix (const FiniteElement<dim> &fe1,
                                        const FiniteElement<dim> &fe2,
                                        boost::shared_ptr<FullMatrix<double> > &matrix)
       {
@@ -1595,7 +1595,7 @@ namespace internal
                                      */
       template <int dim>
       void
-      assert_existence_of_subface_matrix (const FiniteElement<dim> &fe1,
+      ensure_existence_of_subface_matrix (const FiniteElement<dim> &fe1,
                                           const FiniteElement<dim> &fe2,
                                           const unsigned int        subface,
                                           boost::shared_ptr<FullMatrix<double> > &matrix)
@@ -2450,7 +2450,7 @@ namespace internal
                                                         // properties of a
                                                         // finite element onto
                                                         // that mesh
-                        assert_existence_of_subface_matrix
+                        ensure_existence_of_subface_matrix
                           (cell->get_fe(),
                            subface->get_fe(subface_fe_index),
                            c,
@@ -2545,7 +2545,7 @@ namespace internal
                            cell->get_fe().dofs_per_face,
                            ExcInternalError());
 
-                    assert_existence_of_face_matrix
+                    ensure_existence_of_face_matrix
                       (dominating_fe,
                        cell->get_fe(),
                        face_interpolation_matrices
@@ -2638,7 +2638,7 @@ namespace internal
                        Assert (dominating_fe.dofs_per_face <=
                                subface_fe.dofs_per_face,
                                ExcInternalError());
-                        assert_existence_of_subface_matrix
+                        ensure_existence_of_subface_matrix
                           (dominating_fe,
                            subface_fe,
                            sf,
@@ -2738,7 +2738,7 @@ namespace internal
                                                        // for this
                                                        // face are
                                                        // available
-                      assert_existence_of_face_matrix
+                      ensure_existence_of_face_matrix
                         (cell->get_fe(),
                          neighbor->get_fe(),
                          face_interpolation_matrices
index 65a52405e7969977c0538e510806ab18e96856e3..1ce21fe9a10d54cf370bf4627184048e62d7d513 100644 (file)
@@ -55,7 +55,7 @@ namespace internal
                                      */
     template <int dim, int structdim>
     void
-    assert_existence_of_dof_identities (const FiniteElement<dim> &fe1,
+    ensure_existence_of_dof_identities (const FiniteElement<dim> &fe1,
                                        const FiniteElement<dim> &fe2,
                                        boost::shared_ptr<DoFIdentities> &identities)
     {
@@ -2186,7 +2186,7 @@ namespace hp
                                                 // entry in the
                                                 // equivalence
                                                 // table exists
-               internal::hp::assert_existence_of_dof_identities<dim,0>
+               internal::hp::ensure_existence_of_dof_identities<dim,0>
                  (get_fe()[first_fe_index],
                   get_fe()[other_fe_index],
                   vertex_dof_identities[first_fe_index][other_fe_index]);
@@ -2279,7 +2279,7 @@ namespace hp
              const unsigned int
                other_fe_index = line->nth_active_fe_index (f);
 
-             internal::hp::assert_existence_of_dof_identities<dim,1>
+             internal::hp::ensure_existence_of_dof_identities<dim,1>
                ((*finite_elements)[first_fe_index],
                 (*finite_elements)[other_fe_index],
                 line_dof_identities[first_fe_index][other_fe_index]);
@@ -2354,7 +2354,7 @@ namespace hp
              const unsigned int
                other_fe_index = quad->nth_active_fe_index (f);
 
-             internal::hp::assert_existence_of_dof_identities<dim,2>
+             internal::hp::ensure_existence_of_dof_identities<dim,2>
                ((*finite_elements)[first_fe_index],
                 (*finite_elements)[other_fe_index],
                 quad_dof_identities[first_fe_index][other_fe_index]);

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.