]> https://gitweb.dealii.org/ - dealii.git/commitdiff
half implemented function deleted
authorGuido Kanschat <dr.guido.kanschat@gmail.com>
Sat, 16 Jul 2005 10:23:25 +0000 (10:23 +0000)
committerGuido Kanschat <dr.guido.kanschat@gmail.com>
Sat, 16 Jul 2005 10:23:25 +0000 (10:23 +0000)
git-svn-id: https://svn.dealii.org/trunk@11153 0785d39b-7218-0410-832d-ea1e28bc413d

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

index 22e8db1d146d593b5ba30748235dec7d8d1301b9..3e9cabf8bb9d738482db3138988aef13abbb3a63 100644 (file)
@@ -255,81 +255,6 @@ DoFTools::compute_row_length_vector(
   Table<2,Coupling> flux_couplings)
 {
   Assert(false, ExcNotImplemented());
-  
-  const FiniteElement<dim>& fe = dofs.get_fe();
-  const unsigned int ncomp = fe.n_components;
-  
-  Assert (row_lengths.size() == dofs.n_dofs(),
-         ExcDimensionMismatch(row_lengths.size(), dofs.n_dofs()));
-
-  Assert (couplings.n_rows() == couplings.n_cols(),
-         ExcDimensionMismatch(couplings.n_rows(), couplings.n_cols()));
-  Assert (flux_couplings.n_rows() == flux_couplings.n_cols(),
-         ExcDimensionMismatch(flux_couplings.n_rows(), flux_couplings.n_cols()));
-  
-  if (couplings.n_rows() > 1)
-    Assert (couplings.n_rows() == ncomp,
-           ExcDimensionMismatch(couplings.n_rows(), ncomp));
-  if (flux_couplings.n_rows() > 1)
-    Assert (flux_couplings.n_rows() == ncomp,
-           ExcDimensionMismatch(flux_couplings.n_rows(), ncomp));
-
-                                  // Function starts here by
-                                  // resetting the counters.
-  std::fill(row_lengths.begin(), row_lengths.end(), 0);
-                                  // We need the user flags, so we
-                                  // save them for later restoration
-  std::vector<bool> old_flags;
-  user_flags_triangulation.save_user_flags(old_flags);
-  user_flags_triangulation.clear_user_flags();
-  
-  const typename DoFHandler<dim>::cell_iterator end = dofs.end();
-  typename DoFHandler<dim>::active_cell_iterator cell;
-  std::vector<unsigned int> cell_indices(fe.dofs_per_cell);
-  std::vector<unsigned int> face_indices(fe.dofs_per_face);
-  
-  for (cell = dofs.begin(); cell != end; ++cell)
-    {
-      cell->get_dof_indices(cell_indices);
-                                      // At this point, we have
-                                      // counted all dofs
-                                      // contributiong from cells
-                                      // coupled topologically to the
-                                      // adjacent cells, but we
-                                      // subtracted some faces.
-
-                                      // Now, let's go by the faces
-                                      // and add the missing
-                                      // contribution as well as the
-                                      // flux contributions.
-      for (unsigned int iface=0;iface<GeometryInfo<dim>::faces_per_cell;++iface)
-       {
-         if (cell->at_boundary(iface))
-           continue;
-         const bool neighbor_same_level = (cell->neighbor(iface)->level()
-                                           == cell->level());
-         const unsigned int
-           nface = (neighbor_same_level)
-           ? cell->neighbor_of_neighbor(iface)
-           : cell->neighbor_of_coarser_neighbor(iface);
-         typename DoFHandler<dim>::face_iterator face = cell->face(iface);
-         
-                                          // Flux couplings are
-                                          // computed from both sides
-                                          // for simplicity.
-         for (unsigned int i=0;i<fe.dofs_per_face;++i)
-           for (unsigned int j=0;j<fe.dofs_per_face;++j)
-             if (flux_couplings(fe.system_to_component_index(i).first,
-                                fe.system_to_component_index(j).first) == always
-                 ||
-                 flux_couplings(fe.system_to_component_index(i).first,
-                                fe.system_to_component_index(j).first) == nonzero
-                 && fe.has_support_on_face(i, iface)
-                 && fe.has_support_on_face(j, nface))
-               ;// ???
-       }
-    }
-  user_flags_triangulation.load_user_flags(old_flags);
 }
 
 

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.