]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Revert to r32190.
authorMarkus Buerg <buerg@math.tamu.edu>
Sat, 11 Jan 2014 15:57:13 +0000 (15:57 +0000)
committerMarkus Buerg <buerg@math.tamu.edu>
Sat, 11 Jan 2014 15:57:13 +0000 (15:57 +0000)
git-svn-id: https://svn.dealii.org/trunk@32195 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/fe/fe.h
deal.II/source/fe/fe_poly_tensor.cc

index 3c80c906e92ab79cdf3f2fe51a5f88ae01d54563..fda2a7fef32a94f6213cf3d0114f88ce4a905cac 100644 (file)
@@ -1749,8 +1749,7 @@ protected:
                     const unsigned int                       offset,
                     typename Mapping<dim,spacedim>::InternalDataBase &mapping_internal,
                     InternalDataBase                        &fe_internal,
-                    FEValuesData<dim,spacedim>                       &data,
-                    const MappingType                        mapping_type = mapping_covariant) const;
+                    FEValuesData<dim,spacedim>                       &data) const;
 
   /**
    * Given the pattern of nonzero components for each shape function, compute
index d3bbdb807c03535065fce7d1fa64ed71799e7233..4735a210ef462b369c7accc784b3a731637de7e3 100644 (file)
@@ -585,29 +585,9 @@ FE_PolyTensor<POLY,dim,spacedim>::fill_fe_values (
     }
 
   if (flags & update_hessians && cell_similarity != CellSimilarity::translation)
-    {
-      if (mapping_type == mapping_nedelec)
-       {
-         this->compute_2nd (mapping, cell,
-                            typename QProjector<dim>::DataSetDescriptor().cell(),
-                            mapping_data, fe_data, data, mapping_covariant_gradient);
-      
-         for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
-           {
-             const unsigned int first = data.shape_function_to_row_table[i * this->n_components() +
-                                                                         this->get_nonzero_components(i).first_selected_component()];
-        
-             for (unsigned int k = 0; k < n_q_points; ++k)
-               for (unsigned int d = 0; d < dim; ++d)
-                 data.shape_hessians[first + d][k] *= sign_change[i];
-           }
-       }
-    
-      else
-       this->compute_2nd (mapping, cell,
+       this->compute_2nd (mapping, cell,
                           typename QProjector<dim>::DataSetDescriptor().cell(),
                           mapping_data, fe_data, data);
-    }
 }
 
 
@@ -811,25 +791,7 @@ FE_PolyTensor<POLY,dim,spacedim>::fill_fe_face_values (
     }
 
   if (flags & update_hessians)
-    {
-      if (mapping_type == mapping_nedelec)
-       {
-         this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data, mapping_covariant_gradient);
-      
-         for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
-           {
-             const unsigned int first = data.shape_function_to_row_table[i * this->n_components() +
-                                                                         this->get_nonzero_components(i).first_selected_component()];
-        
-             for (unsigned int k = 0; k < n_q_points; ++k)
-               for (unsigned int d = 0; d < dim; ++d)
-                 data.shape_hessians[first + d][k] *= sign_change[i];
-           }
-       }
-    
-      else
-       this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
-    }
+       this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
 }
 
 
@@ -1039,25 +1001,7 @@ FE_PolyTensor<POLY,dim,spacedim>::fill_fe_subface_values (
     }
 
   if (flags & update_hessians)
-    {
-      if (mapping_type == mapping_nedelec)
-       {
-         this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data, mapping_covariant_gradient);
-      
-         for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
-           {
-             const unsigned int first = data.shape_function_to_row_table[i * this->n_components() +
-                                                                         this->get_nonzero_components(i).first_selected_component()];
-        
-             for (unsigned int k = 0; k < n_q_points; ++k)
-               for (unsigned int d = 0; d < dim; ++d)
-                 data.shape_hessians[first + d][k] *= sign_change[i];
-           }
-       }
-    
-      else
-       this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
-    }
+       this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
 }
 
 

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.