]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Finish the rudimentary build system
authormaier <maier@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 7 Aug 2012 22:32:26 +0000 (22:32 +0000)
committermaier <maier@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 7 Aug 2012 22:32:26 +0000 (22:32 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_cmake@25765 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/source/CMakeLists.txt
deal.II/source/distributed/CMakeLists.txt [new file with mode: 0644]
deal.II/source/dofs/CMakeLists.txt [new file with mode: 0644]
deal.II/source/fe/CMakeLists.txt [new file with mode: 0644]
deal.II/source/grid/CMakeLists.txt [new file with mode: 0644]
deal.II/source/hp/CMakeLists.txt [new file with mode: 0644]
deal.II/source/lac/CMakeLists.txt [new file with mode: 0644]
deal.II/source/multigrid/CMakeLists.txt [new file with mode: 0644]
deal.II/source/numerics/CMakeLists.txt [new file with mode: 0644]

index de0d75c972955ba518a50730889e0ba937ece2d7..6c0887504a7595a188ea55d9b66dfb8b9727da00 100644 (file)
@@ -1,3 +1,21 @@
 ADD_SUBDIRECTORY(base)
+ADD_SUBDIRECTORY(distributed)
+ADD_SUBDIRECTORY(dofs)
+ADD_SUBDIRECTORY(fe)
+ADD_SUBDIRECTORY(grid)
+ADD_SUBDIRECTORY(hp)
+ADD_SUBDIRECTORY(lac)
+ADD_SUBDIRECTORY(multigrid)
+ADD_SUBDIRECTORY(numerics)
 
-ADD_LIBRARY(deal.II $<TARGET_OBJECTS:OBJ_BASE>)
+ADD_LIBRARY(deal.II
+  $<TARGET_OBJECTS:OBJ_BASE>
+  $<TARGET_OBJECTS:OBJ_DISTRIBUTED>
+  $<TARGET_OBJECTS:OBJ_DOFS>
+  $<TARGET_OBJECTS:OBJ_FE>
+  $<TARGET_OBJECTS:OBJ_GRID>
+  $<TARGET_OBJECTS:OBJ_HP>
+  $<TARGET_OBJECTS:OBJ_LAC>
+  $<TARGET_OBJECTS:OBJ_MULTIGRID>
+  $<TARGET_OBJECTS:OBJ_NUMERICS>
+  )
diff --git a/deal.II/source/distributed/CMakeLists.txt b/deal.II/source/distributed/CMakeLists.txt
new file mode 100644 (file)
index 0000000..103308b
--- /dev/null
@@ -0,0 +1,7 @@
+set(SRC_DISTRIBUTED
+  grid_refinement.cc
+  solution_transfer.cc
+  tria.cc
+  )
+
+add_library(OBJ_DISTRIBUTED OBJECT ${SRC_DISTRIBUTED})
diff --git a/deal.II/source/dofs/CMakeLists.txt b/deal.II/source/dofs/CMakeLists.txt
new file mode 100644 (file)
index 0000000..6c3736a
--- /dev/null
@@ -0,0 +1,14 @@
+set(SRC_DOFS
+  block_info.cc
+  dof_accessor.cc
+  dof_faces.cc
+  dof_handler.cc
+  dof_handler_policy.cc
+  dof_levels.cc
+  dof_objects.cc
+  dof_renumbering.cc
+  dof_tools.cc
+  number_cache.cc
+  )
+
+add_library(OBJ_DOFS OBJECT ${SRC_DOFS})
diff --git a/deal.II/source/fe/CMakeLists.txt b/deal.II/source/fe/CMakeLists.txt
new file mode 100644 (file)
index 0000000..ab38f42
--- /dev/null
@@ -0,0 +1,32 @@
+set(SRC_FE
+  fe_abf.cc
+  fe_bdm.cc
+  fe.cc
+  fe_data.cc
+  fe_dgp.cc
+  fe_dgp_monomial.cc
+  fe_dgp_nonparametric.cc
+  fe_dgq.cc
+  fe_dg_vector.cc
+  fe_face.cc
+  fe_nedelec.cc
+  fe_nothing.cc
+  fe_poly.cc
+  fe_poly_tensor.cc
+  fe_q.cc
+  fe_q_hierarchical.cc
+  fe_raviart_thomas.cc
+  fe_raviart_thomas_nodal.cc
+  fe_system.cc
+  fe_tools.cc
+  fe_values.cc
+  mapping_c1.cc
+  mapping_cartesian.cc
+  mapping.cc
+  mapping_q1.cc
+  mapping_q1_eulerian.cc
+  mapping_q.cc
+  mapping_q_eulerian.cc
+  )
+
+add_library(OBJ_FE OBJECT ${SRC_FE})
diff --git a/deal.II/source/grid/CMakeLists.txt b/deal.II/source/grid/CMakeLists.txt
new file mode 100644 (file)
index 0000000..1e3d466
--- /dev/null
@@ -0,0 +1,19 @@
+set(SRC_GRID
+  grid_generator.cc
+  grid_in.cc
+  grid_out.cc
+  grid_refinement.cc
+  grid_reordering.cc
+  grid_tools.cc
+  intergrid_map.cc
+  persistent_tria.cc
+  tria_accessor.cc
+  tria_boundary.cc
+  tria_boundary_lib.cc
+  tria.cc
+  tria_faces.cc
+  tria_levels.cc
+  tria_objects.cc
+  )
+
+add_library(OBJ_GRID OBJECT ${SRC_GRID})
diff --git a/deal.II/source/hp/CMakeLists.txt b/deal.II/source/hp/CMakeLists.txt
new file mode 100644 (file)
index 0000000..0b23fc2
--- /dev/null
@@ -0,0 +1,11 @@
+set(SRC_HP
+  dof_faces.cc
+  dof_handler.cc
+  dof_levels.cc
+  dof_objects.cc
+  fe_collection.cc
+  fe_values.cc
+  mapping_collection.cc
+  )
+
+add_library(OBJ_HP OBJECT ${SRC_HP})
diff --git a/deal.II/source/lac/CMakeLists.txt b/deal.II/source/lac/CMakeLists.txt
new file mode 100644 (file)
index 0000000..80ea10e
--- /dev/null
@@ -0,0 +1,63 @@
+set(SRC_LAC
+  block_matrix_array.cc
+  block_sparse_matrix.cc
+  block_sparse_matrix_ez.cc
+  block_sparsity_pattern.cc
+  block_vector.cc
+  chunk_sparse_matrix.cc
+  chunk_sparsity_pattern.cc
+  compressed_set_sparsity_pattern.cc
+  compressed_simple_sparsity_pattern.cc
+  compressed_sparsity_pattern.cc
+  constraint_matrix.cc
+  full_matrix.cc
+  lapack_full_matrix.cc
+  matrix_lib.cc
+  matrix_out.cc
+  operator.cc
+  parallel_vector.cc
+  petsc_block_sparse_matrix.cc
+  petsc_full_matrix.cc
+  petsc_matrix_base.cc
+  petsc_parallel_block_sparse_matrix.cc
+  petsc_parallel_block_vector.cc
+  petsc_parallel_sparse_matrix.cc
+  petsc_parallel_vector.cc
+  petsc_precondition.cc
+  petsc_solver.cc
+  petsc_sparse_matrix.cc
+  petsc_vector_base.cc
+  petsc_vector.cc
+  precondition_block.cc
+  precondition_block_ez.cc
+  relaxation_block.cc
+  slepc_solver.cc
+  slepc_spectral_transformation.cc
+  solver.cc
+  solver_control.cc
+  sparse_decomposition.cc
+  sparse_direct.cc
+  sparse_ilu.cc
+  sparse_matrix.cc
+  sparse_matrix_ez.cc
+  sparse_mic.cc
+  sparse_vanka.cc
+  sparsity_pattern.cc
+  sparsity_tools.cc
+  swappable_vector.cc
+  timestep_control.cc
+  tridiagonal_matrix.cc
+  trilinos_block_sparse_matrix.cc
+  trilinos_block_vector.cc
+  trilinos_precondition.cc
+  trilinos_solver.cc
+  trilinos_sparse_matrix.cc
+  trilinos_sparsity_pattern.cc
+  trilinos_vector_base.cc
+  trilinos_vector.cc
+  vector.cc
+  vector_memory.cc
+  vector_view.cc
+  )
+
+add_library(OBJ_LAC OBJECT ${SRC_LAC})
diff --git a/deal.II/source/multigrid/CMakeLists.txt b/deal.II/source/multigrid/CMakeLists.txt
new file mode 100644 (file)
index 0000000..2bc54ce
--- /dev/null
@@ -0,0 +1,12 @@
+set(SRC_MULTIGRID
+  mg_base.cc
+  mg_dof_accessor.cc
+  mg_dof_handler.cc
+  mg_tools.cc
+  mg_transfer_block.cc
+  mg_transfer_component.cc
+  mg_transfer_prebuilt.cc
+  multigrid.cc
+  )
+
+add_library(OBJ_MULTIGRID OBJECT ${SRC_MULTIGRID})
diff --git a/deal.II/source/numerics/CMakeLists.txt b/deal.II/source/numerics/CMakeLists.txt
new file mode 100644 (file)
index 0000000..6b95ce2
--- /dev/null
@@ -0,0 +1,23 @@
+set(SRC_NUMERICS
+  data_out.cc
+  data_out_faces.cc
+  data_out_rotation.cc
+  data_out_stack.cc
+  data_postprocessor.cc
+  derivative_approximation.cc
+  error_estimator.cc
+  fe_field_function.cc
+  histogram.cc
+  matrices.cc
+  matrix_free.cc
+  mesh_worker.cc
+  mesh_worker_info.cc
+  mesh_worker_vector_selector.cc
+  operator.cc
+  point_value_history.cc
+  solution_transfer.cc
+  time_dependent.cc
+  vectors.cc
+  )
+
+add_library(OBJ_NUMERICS OBJECT ${SRC_NUMERICS})

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.