]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Make this test compile at least.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 29 Feb 2000 17:56:45 +0000 (17:56 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 29 Feb 2000 17:56:45 +0000 (17:56 +0000)
git-svn-id: https://svn.dealii.org/trunk@2522 0785d39b-7218-0410-832d-ea1e28bc413d

tests/big-tests/nonlinear/fixed-point-iteration/Makefile
tests/big-tests/nonlinear/fixed-point-iteration/nonlinear.cc

index 7598a66d685e5e9deb9100ab21385449015a0d22..6d6f4c8d4c3253fba297ce9d515dfb0e9b07cdee 100644 (file)
@@ -43,7 +43,7 @@ delete-files = gnuplot* *.eps
 # Internals
 
 
-include $D/Make.global_options
+include $D/common/Make.global_options
 
 
 
@@ -52,7 +52,9 @@ cc-files    = $(filter-out *%, $(shell echo *.cc))
 o-files     = $(cc-files:.cc=.o)
 go-files    = $(cc-files:.cc=.go)
 h-files     = $(filter-out *%, $(shell echo *.h))
-lib-h-files = $(filter-out *%, $(shell echo ../../include/*.h))
+lib-h-files = $(filter-out *%, $(shell echo $D/base/include/base/*.h \
+                                            $D/lac/include/lac/*.h  \
+                                            $D/deal.II/include/*/*.h))
 
 # list of libraries needed to link with
 libs.g   = ./Obj.g.a         \
@@ -102,7 +104,7 @@ run: $(target)
 %.o : %.cc
        @echo ============================ Compiling with optimization:   $<
        @echo $(CXX) ... -c $< -o $@
-       @$(CXX) $(CXXFLAGS) -c $< -o $@
+       @$(CXX) $(CXXFLAGS.o) -c $< -o $@
 
 
 # rules which files the libraries depend upon
@@ -129,7 +131,7 @@ clean:
 #rather for libnumerics.a(tria.o)
 Makefile.dep: $(cc-files) $(h-files) $(lib-h-files)
        @echo ============================ Remaking Makefile
-       @perl ../../../Make_dep.pl ./Obj $(INCLUDE) $(cc-files) \
+       @$(PERL) $D/common/scripts/Make_dep.pl ./Obj $(INCLUDE) $(cc-files) \
                > Makefile.dep
 
 
index 30155302fa831eb2d86ea51a5a7b0a523199de0d..17fecd7db919f7433b25637d1c610ac8cdaa4974 100644 (file)
@@ -12,7 +12,7 @@
 #include <grid/tria_iterator.h>
 #include <grid/tria_boundary.h>
 #include <grid/grid_generator.h>
-#include <numerics/data_io.h>
+#include <numerics/data_out.h>
 #include <base/function.h>
 #include <fe/fe_lib.lagrange.h>
 #include <base/quadrature_lib.h>
@@ -110,9 +110,9 @@ void PoissonEquation<dim>::assemble (FullMatrix<double>  &cell_matrix,
   right_hand_side.value_list (fe_values.get_quadrature_points(), rhs_values);
    
   for (unsigned int point=0; point<fe_values.n_quadrature_points; ++point)
-    for (unsigned int i=0; i<fe_values.total_dofs; ++i) 
+    for (unsigned int i=0; i<fe_values.dofs_per_cell; ++i) 
       {
-       for (unsigned int j=0; j<fe_values.total_dofs; ++j)
+       for (unsigned int j=0; j<fe_values.dofs_per_cell; ++j)
          cell_matrix(i,j) += (gradients[i][point] *
                               gradients[j][point]) *
                              weights[point] /
@@ -158,7 +158,7 @@ void NonlinearProblem<dim>::run () {
   clear ();
   
   tria = new Triangulation<dim>();
-  dof = new DoFHandler<dim> (tria);
+  dof = new DoFHandler<dim> (*tria);
   set_tria_and_dof (tria, dof);
 
 
@@ -166,7 +166,7 @@ void NonlinearProblem<dim>::run () {
   ZeroFunction<dim>     boundary_values;
   StraightBoundary<dim> boundary;
   
-  FELinear<dim>                   fe;
+  FEQ1<dim>                       fe;
   PoissonEquation<dim>            equation (rhs, last_solution);
   QGauss2<dim>                    quadrature;
   
@@ -174,7 +174,7 @@ void NonlinearProblem<dim>::run () {
   dirichlet_bc[0] = &boundary_values;
 
 
-  GridGenerator::hypercube (*tria);
+  GridGenerator::hyper_cube (*tria);
   tria->refine_global (4);
 
   for (unsigned int refinement_step=0; refinement_step<10; ++refinement_step)
@@ -198,7 +198,7 @@ void NonlinearProblem<dim>::run () {
        {
          cout << "    Nonlinear step " << nonlinear_step << endl;
          cout << "        Assembling matrices..." << endl;
-         assemble (equation, quadrature, fe,
+         assemble (equation, quadrature,
                    UpdateFlags(update_values | update_gradients |
                                update_JxW_values | update_q_points),
                    dirichlet_bc);
@@ -228,10 +228,10 @@ void NonlinearProblem<dim>::run () {
       Vector<float> error_indicator;
       KellyErrorEstimator<dim> ee;
       QSimpson<dim-1> eq;
-      ee.estimate_error (*dof, eq, fe,
-                        KellyErrorEstimator<dim>::FunctionMap(),
-                        solution,
-                        error_indicator);
+      ee.estimate (*dof, eq,
+                  KellyErrorEstimator<dim>::FunctionMap(),
+                  solution,
+                  error_indicator);
       tria->refine_and_coarsen_fixed_number (error_indicator, 0.3, 0);
       tria->execute_coarsening_and_refinement ();
     };

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.