From a1250a64775c03afaa9ab0141971fbb7ce1ba838 Mon Sep 17 00:00:00 2001 From: kanschat Date: Tue, 30 Aug 2011 16:30:56 +0000 Subject: [PATCH] bibtex and standardize git-svn-id: https://svn.dealii.org/trunk@24218 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/doc/documentation.html | 8 +- deal.II/doc/license.html | 4 +- deal.II/doc/navbar.html | 4 +- deal.II/doc/publications/index.html | 3429 +++++++++++++++++++++++++ deal.II/doc/publications/toc.html | 3610 --------------------------- deal.II/doc/readme.html | 4 +- 6 files changed, 3439 insertions(+), 3620 deletions(-) create mode 100644 deal.II/doc/publications/index.html delete mode 100644 deal.II/doc/publications/toc.html diff --git a/deal.II/doc/documentation.html b/deal.II/doc/documentation.html index 0fd05bd998..99222855cc 100644 --- a/deal.II/doc/documentation.html +++ b/deal.II/doc/documentation.html @@ -97,7 +97,7 @@

There are a number of papers that describe the overall design or individual aspects of deal.II. Please refer to the - papers listed at the top of the publications page for full references. In addition, there are the following reports:

This is the usual, fair way of giving credit to contributors to a scientific result. In addition, it helps us justify our effort in @@ -91,7 +91,7 @@

- We keep a list of publications + We keep a list of publications using deal.II. Feel free to let us know about your publications. diff --git a/deal.II/doc/navbar.html b/deal.II/doc/navbar.html index 68892a2ad1..8f7dcfcd73 100644 --- a/deal.II/doc/navbar.html +++ b/deal.II/doc/navbar.html @@ -5,7 +5,7 @@ deal.II navigation bar - + @@ -39,7 +39,7 @@

Development
- Publications
+ Publications
Presentations
Authors
License diff --git a/deal.II/doc/publications/index.html b/deal.II/doc/publications/index.html new file mode 100644 index 0000000000..e098341fd1 --- /dev/null +++ b/deal.II/doc/publications/index.html @@ -0,0 +1,3429 @@ + + + + + + The deal.II Publication List + + + + + + + + +

Publications on and with deal.II

+ +

+ Our institutes are evaluated at regular intervals. Consequently, + we are interested in documenting the use of the programs and + libraries we create. To this end, this page collects + publications written on or with the help of + deal.II. If you have written + something, please let us know about it: the more comprehensive this + list is, the simpler it is for us to justify to our departments and + sponsors the effort we put into the library — something that helps all + of us in the end. +

+ +

+ Some other resources on the use of deal.II or its + development can also be found on + a page + where we collect a few presentations. +

+ +

+ + + + + + + + +
Table of contents
+
    +
  1. Referencing deal.II +
  2. Publications on details + of deal.II +
  3. Publications per year:
    + 2010 + 2011 +
    + 2000 + 2001 + 2002 + 2003 + 2004 + 2005 + 2006 + 2007 + 2008 + 2009 +
    + 1998 + 1999 +
+
+ + + +

Referencing deal.II

+ +

+ For your convenience, we provide a BibTeX file with entries + for the publications in this section. +

+ +

+ If you write a paper using results obtained with the help of + deal.II, please cite one or both of the following + references: +

+ +
    +
  1. W. Bangerth, + R. Hartmann and + G. Kanschat +
    + + deal.II — a general-purpose object-oriented finite element library + +
    + ACM Transactions on Mathematical Software, vol. 33, no. 4, article 24 +
    + DOI 10.1145/1268776.1268779 + (Preprint) +
    +
    +	  @Article{BangerthHartmannKanschat2007,
    +	  author = 	 {Wolfgang Bangerth and Ralf Hartmann and Guido Kanschat},
    +	  title = 	 {{deal.II} -- a General Purpose Object Oriented Finite Element Library},
    +	  journal = 	 {ACM Trans. Math. Softw.},
    +	  year = 	 2007,
    +	  volume = 	 33,
    +	  number = 	 4,
    +	  pages = 	 {24/1--24/27}
    +	  }
    +
  2. +
  3. W. Bangerth + and + G. Kanschat +
    + deal.II Differential Equations + Analysis Library, Technical Reference + +
    + To be found on the project webpage http://www.dealii.org +
    +
    +	  @Manual{DealIIReference,
    +	  title = 	 {{\tt deal.{I}{I}} Differential Equations Analysis Library,
    +          Technical Reference},
    +	  author = 	 {W. Bangerth and G. Kanschat},
    +	  note =         {\texttt{http://www.dealii.org}},
    +	  url =          {http://www.dealii.org}
    +	  }
    +
  4. +
+ + + + + + + + + + +

Publications on details of deal.II

+ +

+ The following publications explain in great detail the + implementation of algorithms and data structures of the hp, multigrid and + distributed mesh components of deal.II: +

+ +
    +
  1. + B. Janssen, + G. Kanschat, +
    + Adaptive Multilevel Methods with Local Smoothing for H1- + and Hcurl-Conforming High Order Finite Element Methods +
    + SIAM J. Sci. Comput., vol. 33/4, pp. 2095-2114, 2011 +
    + DOI: 10.1137/090778523 +
  2. + +
  3. + W. Bangerth, + C. Burstedde, T. Heister, M. Kronbichler +
    + Algorithms and Data Structures for Massively Parallel Generic + Finite Element Codes +
    + to appear in ACM Trans. Math. Softw. + IAMCS + preprint 2011-187. + +
  4. + W. Bangerth, O. Kayser-Herold, +
    + Data Structures and Requirements for hp Finite Element + Software + +
    + ACM Trans. Math. Softw., vol. 36, pp. 4/1-31, 2009 +
  5. + +
  6. + G. Kanschat +
    + Multi-level methods for discontinuous Galerkin FEM on locally refined meshes +
    + Comput. & Struct., vol. 82, pp. 2437-2445, 2004 +
  7. +
+ +

For massively parallel + computations, deal.II builds on the + p4est + library. If you use this functionality, please also cite the + p4est paper listed at their website. +

+

+ deal.II is a component of the SPEC CPU2006 benchmark + suite. There are hundreds of papers that use and describe this + testsuite as a reference for compiler and hardware + optimizations. The following special issue gives a detailed + comparison with respect to many different metrics of the + benchmarks in SPEC CPU2006, including deal.II: +

+ + +

Publications in 2011

+ + +
    +
  1. M. Allmaras, W. Bangerth +
    + Reconstructions in ultrasound modulated optical tomography + +
    + J. Inverse and Ill-posed Problems, accepted, 2011. +
  2. + +
  3. F. Alouges, A. DeSimone, L. Heltai +
    + Numerical strategies for stroke optimization of + axisymmetric microswimmers + +
    + Mathematical Models and Methods in Applied Sciences, vol. 3, 2011. +
  4. + +
  5. M. Arroyo, A. DeSimone, L. Heltai +
    + The role of membrane viscosity in the dynamics of fluid + membranes + +
    + arXiv:1007.4934, submitted, 2010. +
  6. + +
  7. W. Bangerth, + C. Burstedde, T. Heister, M. Kronbichler +
    + Algorithms and Data Structures for Massively Parallel Generic + Finite Element Codes +
    + Accepted for publication in the ACM Trans. Math. Softw. This paper is + also available as + IAMCS + preprint 2011-187 + +
  8. K. Benzarti, F. Freddi, M. Frémond +
    + A damage model to predict the durability of bonded + assemblies. Part I: Debonding behavior of FRP strengthened + concrete structures +
    + Construction and Building Materials, 25(2),547-555, 2011. +
  9. + +
  10. L. Blank, L. Sarbu, M. Stoll +
    + Preconditioning for Allen-Cahn variational + inequalities with non-local constraints +
    + submitted. Preprint 11/2010, Mathematik, Uni Regensburg, 2010. +
  11. + +
  12. A. Buehler, A. Rosenthal, T. Jetzfellner, A. Dima, + D. Razansky, V. Ntziachristos +
    + Model-based optoacoustic inversions with incomplete projection + data +
    + Med. Phys., vol. 38, pp. 1694-1704, 2011. +
  13. + +
  14. Y. Efendiev, J. Galvis, R. Lazarov, J. Willems +
    + Robust Domain Decomposition Preconditioners for Abstract + Symmetric Positive Definite Bilinear Forms + +
    + arXiv:1105.1131v1 [math.NA] +
  15. + +
  16. E. Emmrich, D. Šiška +
    + Full discretization of second-order nonlinear evolution + equatiosn: Strong convergence and applications + +
    + Preprint, University of Bielefeld, 2011. +
  17. + +
  18. M. Freyer +
    + Automatische Segmentierung anatomischer Strukturen in + CT-Bildern eines hybriden FMT/XCT-Systems zur Verbesserung der + optischen Bildgebung + +
    + Ph.D. thesis, Ludwig-Maximilians-University Munich, Germany, 2011. +
  19. + +
  20. J. Frohne +
    + FEM-Simulation der Umformtechnik metallischer + Oberflächen im Mikrokosmos + +
    + Ph.D. thesis, University of Siegen, Germany, 2011. +
  21. + +
  22. T. George, A. Gupta, V. Sarin +
    + An empirical analysis of the performance of iterative + solvers for SPD systems + +
    + Submitted to ACM Trans. Math. Softw., 2011. +
  23. + +
  24. A. Ginzburg +
    + Introduction to Geophysics (in Hebrew) + +
    + The Open University of Israel, 2011. +
  25. + +
  26. J.-L. Guermond, A. Salgado +
    + Error analysis of a fractional time-stepping technique for + incompressible + flows with variable density. + +
    + SIAM J. of Numerical Analysis, vol. 49, pp. 917-944, 2011. +
  27. + +
  28. R. Hartmann, J. Held, T. Leicht +
    + Adjoint-based error estimation and adaptive mesh refinement + for the RANS and k-ω turbulence model equations + +
    + J. Comput. Phys., accepted, 2010. +
  29. + +
  30. R. Hartmann, J. Held, T. Leicht, F. Prill +
    + Error estimation and adaptive mesh refinement for aerodynamic flows + +
    + In N. Kroll, H. Bieler, H. Deconinck, V. Couallier, H. van der Ven and K. Sorensen, editors, + ADIGMA - A European Initiative on the Development of Adaptive + Higher-Order Variational Methods for Aerospace Applications, + Springer, to appear, 2010. +
  31. + +
  32. T. Heister +
    + A Massively Parallel Finite Element Framework with + Application to Incompressible Flows +
    + Ph.D. thesis, University of Göttingen, Germany, 2011 +
  33. + +
  34. B. Janssen, G. Kanschat +
    + Adaptive multilevel methods with local smoothing +
    + submitted, 2010. +
  35. + +
  36. G. Jegert, A. Kersch, W. Weinreich, P. Lugli +
    + Monte Carlo Simulation of Leakage Currents in + TiN/ZrO2/TiN Capacitors +
    + IEEE Transactions on Electron Devices, vol. 58, pp. 327-334, 2011. +
  37. + +
  38. M. Hinze, M. Kunkel, A. Steinbrecher, T. Stykel +
    + Model order reduction of coupled circuit-device systems +
    + Hamburger Beiträge zur Angewandten Mathematik, Nr. 2011-08. +
  39. + +
  40. B. Janssen, + T. Wick +
    + Block Preconditioning with Schur Complements + for Monolithic Fluid-Structure Interactions +
    + Eccomas CFD 2010 proceedings, submitted, 2010. +
  41. + +
  42. O. P. Iliev, R. D. Lazarov, J. Willems +
    + Variational multiscale finite element method for flows in + highly porous media +
    + SIAM Multiscale Modeling and Simulation, submitted, 2010 +
  43. + +
  44. T. Leicht, R. Hartmann +
    + Error estimation and hp-adaptive mesh refinement for + discontinuous Galerkin methods + +
    + In Z. J. Wang, editor, Adaptive High-Order Methods in + Computational Fluid Dynamics - with applications in aerospace + engineering, World Science Books, to appear, 2010. +
  45. + +
  46. T. Leicht, R. Hartmann +
    + Goal-oriented error estimation and hp-adaptive mesh + refinement for aerodynamic flows. + +
    + 49thAIAA Aerospace Sciences Meeting, submitted, 2010. +
  47. + +
  48. C. E. Michoski, J. A. Evans, P. G. Schmitz +
    + Modeling Chemical Reactors I: Quiescent Reactors + +
    + Preprint, arXiv, 2010 +
  49. + +
  50. T. Richter, T. Wick +
    + Fluid-Structure Interactions in ALE and + Fully Eulerian Coordinates + +
    + PAMM, submitted, 2010. +
  51. + +
  52. A. Salgado +
    + A Diffuse Interface Fractional Time-Stepping Technique + for Incompressible Two-Phase Flows with Moving Contact Lines. + +
    + Submitted to Comp. Meths. Appl. Mech. Engrg., 2011. +
  53. + +
  54. T. Wick +
    + Fluid-Structure Interaction based on Monolithic Variational + Formulations with Different Types of Pseudo-Structure Extension + +
    + submitted, 2010 +
  55. + +
  56. T. Wick +
    + Solving Monolithic Fluid-Structure Interaction Problems in + Arbitrary Lagrangian Eulerian Coordinates with the deal.II Library + +
    + IWR Report, University of Heidelberg, Germany, 2011. +
  57. + +
  58. T. D. Young +
    + A qualitative semi-classical treatment of an isolated + semi-polar quantum dot + +
    + J. Phys.: Conf. Ser., 28(10), 2011. +
  59. + +
  60. L. Zhou, B. Yazici +
    + Discretization Error Analysis and Adaptive Meshing + Algorithms for Fluorescence Diffuse Optical Tomography in the + Presence of Measurement Noise +
    + IEEE Trans. Image Processing, vol. 20, pp. 1094-1111, 2011 +
  61. + +
  62. L. Zhu, D. Schötzau +
    + A robust a posteriori error estimate for hp-adaptive DG + methods for convection-diffusion equations + +
    + IMA J. Numer. Math., in press, 2010 +
  63. +
+ + +

Publications in 2010

+ + +
    +
  1. M. S. Alnæs, K.-A. Mardal +
    + On the efficiency of symbolic computations combined with code + generation for finite element methods + +
    + ACM Transactions on Mathematical Software, vol. 37, 8/1-26, 2010. +
  2. + +
  3. W. Bangerth, M. Geiger, R. Rannacher +
    + Adaptive Galerkin finite element methods + for the wave equation + +
    + Computational Methods in Applied Mathematics, vol. 10, pp.3-48, 2010. +
  4. + +
  5. S. Bartle, A. McBride, B. D. Reddy +
    + Shell finite elements, with applications in biomechanics +
    + In: Kok, S. (Ed.): Proceedings of 7th South African Conference on + Computational and Applied Mechanics (University of Pretoria, Pretoria, + South Africa). 2010. +
  6. + +
  7. A. Cangiani, R. Natalini +
    + A spatial model of cellular molecular trafficking + including active transport along microtubules +
    + Journal of Theoretical Biology, vol. 267, pp. 614-625, 2010. +
  8. + +
  9. C.-C. Chueh, M. Secanell, W. Bangerth, N. Djilali +
    + Multi-level Adaptive Simulation of Transient Two-phase Flow in + Heterogeneous Porous Media +
    + Computers and Fluids, vol. 39, pp. 1585-1596, 2010. +
  10. + +
  11. C.-C. Chueh +
    + Integrated adaptive numerical methods for transient + two-phase flow in heterogeneous porous medi +
    + Ph.D. thesis, University of Victoria, 2010. +
  12. + +
  13. T. Dally +
    + FE-Modelladaptivität für P-Laplace + +
    + Master's thesis, Universität Siegen, Germany, 2010 +
  14. + +
  15. M. Freyer, A. Ale, R. Schulz, M. Zientkowska, + V. Ntziachristos, K.-H. Englmeier +
    + Fast automatic segmentation of anatomical structures + in x-ray computed tomography images to improve fluorescence + molecular tomography reconstruction +
    + Journal of Biomedical Optics, vol. 15, pp. 036006/1-8, 2010. +
    +
  16. + +
  17. F. Freddi, M. Frémond +
    + Collision and Fractures: a predictive theory + +
    + European Journal of Mechanics - A/Solids, vol. 29, pp. 998-1007, 2010. +
  18. + +
  19. F. Freddi, G. Royer-Carfagni +
    + Regularized Variational Theories of Fracture: a + Unified Approach +
    + Journal of the Mechanics and Physics of Solids, vol. 58, + pp. 1154-1174, 2010. +
  20. + +
  21. P. Ghysels, G. Samaey, P. Van Liedekerke, E. Tijskens, + H. Ramon, D. Roose +
    + Multiscale modeling of viscoelastic plant tissue + +
    + Int. J. Multisc. Comput. Engrg., vol. 8, pp. 379-396, 2010 +
  22. + +
  23. P. Ghysels, G. Samaey, P. Van Liedekerke, E. Tijskens, + H. Ramon, D. Roose +
    + Coarse implicit time integration of a cellular scale particle + model for plant tissue deformation + +
    + Int. J. Multisc. Comput. Engrg., vol. 8, pp. 411-422, 2010 +
  24. + +
  25. V. Girault, F. Murat, A. Salgado +
    + Finite element discretization of Darcy's equations with + pressure dependent porosity. + +
    + M2AN, vol. 44, pp. 1155-1191, 2010 +
  26. + +
  27. M. Guven, L. Reilly-Raska, L. Zhou, B. Yazici +
    + Discretization Error Analysis and Adaptive Meshing + Algorithms for Fluorescence Diffuse Optical Tomography: Part + I +
    + IEEE Trans. Medical Imaging, vol. 29, pp. 217-229, 2010 +
  28. + +
  29. M. Guven, L. Zhou, L. Reilly-Raska, B. Yazici +
    + Discretization Error Analysis and Adaptive Meshing + Algorithms for Fluorescence Diffuse Optical Tomography: Part + II +
    + IEEE Trans. Medical Imaging, vol. 29, pp. 230-245, 2010 +
  30. + +
  31. R. Hartmann, J. Held, T. Leicht, F. Prill +
    + Discontinuous Galerkin methods for computational aerodynamics + — 3D adaptive flow simulation with the DLR PADGE code + +
    + Aerospace Science and Technology, vol. 14, pp. 512-529, 2010. +
  32. + +
  33. R. Hartmann, P. Houston +
    + Error estimation and adaptive mesh refinement for aerodynamic flows +
    + In H. Deconinck, editor, + VKI LS 2010-01: 36th CFD/ADIGMA course on hp-adaptive and + hp-multigrid methods, Oct. 26-30, 2009. +
    + Von Karman Institute for Fluid Dynamics, Rhode Saint Genese, + Belgium, 2010. +
  34. + +
  35. R. Hartmann, T. Leicht +
    + Discontinuous Galerkin Verfahren in der Aerodynamik: + Höhere Ordnung, Fehlerschätzung und Gitteradaption + +
    + STAB Mitteilungen. 17. DGLR-Fach-Symposium der STAB, 9.-10. Nov. 2010, Berlin, 2010. +
  36. + +
  37. T. Heister, G. Lube, G. Rapin +
    + On robust parallel preconditioning for incompressible + flow problems +
    + In Numerical Mathematics and Advanced Applications, ENUMATH 2009. + Springer, Berlin, 2010. +
  38. + +
  39. T. Heister, M. Kronbichler, W. Bangerth +
    + Generic Finite Element programming for massively parallel + flow simulations +
    + Eccomas CFD 2010 proceedings, 2010. +
  40. + +
  41. T. Heister, M. Kronbichler, W. Bangerth +
    + Massively Parallel Finite Element Programming +
    + Recent Advances in the Message Passing Interface, + Lecture Notes in Computer Science, vol. 6305/2010, pp. 122-131, + 2010. +
  42. + +
  43. O. P. Iliev, R. D. Lazarov, J. Willems +
    + Discontinuous Galerkin Subgrid Finite Element Method for + Heterogeneous Brinkman Equations +
    + Large-Scale Scientific Computing, Lectures Notes in Computer Science, + vol. 5910, pp. 14-25, 2010 +
  44. + +
  45. O. P. Iliev, R. D. Lazarov, J. Willems +
    + Fast numerical upscaling of heat equation for fibrous + materials +
    + J. Computing and Visualization in Science, vol. 13, pp. 275-285, 2010 +
  46. + +
  47. G. Kanschat, B. Rivière +
    + A strongly conservative finite element method for the coupling + of Stokes and Darcy flow + +
    + J. Computational Physics, vol. 229, pp. 5933-5943, 2010 +
  48. + +
  49. F. Keller, M. Feist, H. Nirschl, W. Dörfler +
    + Investigation of the nonlinear effects during the + sedimentation process of a charged colloidal particle by + direct numerical simulation + +
    + Journal of Colloid and Interface Science, vol. 344, pp. 228-236, 2010. +
  50. + +
  51. S. Kim, J. E. Pasciak +
    + Analysis of a Cartesian PML approximation to acoustic + scattering problems in R2 +
    + J. Math. Anal. Appl., vol. 370, pp. 168-186, 2010 +
  52. + +
  53. + R. King, V. Mehrmann, W. Nitsche +
    + Active Flow Control—A Mathematical Challenge +
    + Production Factor Mathematics, Part 1, pp. 73-80, 2010 +
  54. + +
  55. + R. King, V. Mehrmann, W. Nitsche +
    + Aktive Strömungsbeeinflussung — Eine + Mathematische Herausforderung +
    + Produktionsfaktor Mathematik, Part 2, pp. 99-109, 2010 +
  56. + +
  57. + T. Leicht, R. Hartmann +
    + Error estimation and anisotropic mesh refinement for + 3d laminar aerodynamic flow simulations + +
    + J. Comput. Phys., vol. 229, pp. 7344-7360, 2010. +
  58. + +
  59. + T. Leicht, R. Hartmann +
    + Error estimation and anisotropic mesh refinement for + aerodynamic flow simulations + +
    + In Numerical Mathematics and Advanced Applications, ENUMATH + 2009, pp. 579-587. Springer, Berlin, 2010. +
  60. + +
  61. + G. Lube, B. Tews +
    + Optimal control of singularly perturbed + advection-diffusion-reaction problems +
    + Math. Model. Meths. Appl. Sc., Vol. 20, No. 3, 375-395, 2010. + (DOI)
    + Preprint 2008-15, Institute for Numerical and Applied + Mathematics, University of Göttingen, Germany, 2008 +
  62. + +
  63. C. P. T. Neuen +
    + A multiscale approach to the Poisson-Nernst-Planck equation + +
    + Diploma Thesis, University of Bonn, Germany, 2010 +
  64. + +
  65. + A. Nigro, C. De Bartolo, R. Hartmann, F. Bassi +
    + Discontinuous Galerkin solution of preconditioned Euler equations for very low Mach number flows + +
    + Int. J. Numer. Meth. Fluids, vol. 63, no. 4, pp. 449-467, 2010. +
  66. + +
  67. + F. Prill +
    + Diskontinuierliche Galerkin-Methoden und schnelle iterative + Löser zur Simulation kompressibler Strömungen + +
    + PhD thesis, TU Hamburg-Harburg, 2010. (in German) +
    + Also available as DLR-FB 2010-17, DLR, 2010. ISSN 1434-8454. +
  68. + +
  69. K. Rupp +
    + Symbolic integration at compile time in finite element methods + +
    + Proceedings of the 2010 International Symposium on Symbolic + and Algebraic Computation, 347-354, 2010. +
  70. + +
  71. + T. Rees, M. Stoll, A. Wathen +
    + All-at-once preconditioning in PDE-constrained + optimization + +
    + Kybernetica, vol. 46, pp. 341-360, 2010. +
  72. + +
  73. + T. Richter, T. Wick +
    + Finite Elements for Fluid-Structure + Interaction in ALE and Fully Eulerian Coordinates + +
    + Comput. Meth. Appl. Mech. Engrg., vol. 199, pp. 2633-2642, 2010. +
  74. + +
  75. + L. Röhe, G. Lube +
    + Analysis of a variational multiscale method for large-eddy + simulation and its application to homogeneous isotropic turbulence + +
    + Comput. Meth. Appl. Mech. Engrg., vol. 199, pp. 2331-2342, 2010. +
  76. + +
  77. + A. Salgado +
    + Approximation Techniques for Incompressible Flows + with Heterogeneous Properties +
    + Ph.D. thesis, Texas A&M University, 2010. +
  78. + +
  79. R. Schulz, A. Ale, A. Sarantopoulos, M. Freyer, E. Soehngen, + M. Zientkowska, V. Ntziachristos +
    + Hybrid System for Simultaneous Fluorescence and X-Ray + Computed Tomography +
    + IEEE Trans. Medical Imaging, vol. 29, pp. 465-473, 2010 +
  80. + +
  81. M. Secanell, R. Songprakorp, N. Djilali, A. Suleman +
    + Optimization of a proton exchange membrane fuel cell + electrode assembly + +
    + Structural and Multidisciplinary Optimization, vol. 40, pp. 563-583, + 2010 +
  82. + +
  83. + M. Steigemann, M. Specovius-Neugebauer, M. Fulland, H. A. Richard +
    + Simulation of crack paths in functionally graded materials + +
    + Engineering Fracture Mechanics, vol. 77, pp. 2145-2157, 2010 +
  84. + +
  85. + M. Stoll, A. Wathen +
    + All-at-once preconditioning of time-dependent PDE-constrained + optimization problems + +
    + Preprint 1017, University of Oxford, 2010. +
  86. + +
  87. + B. Turcksin, J. C. Ragusa, W. Bangerth +
    + Goal-oriented h-adaptivity for the multigroup SPN + equations + +
    + Nuclear Science and Engineering, vol. 165, pp. 305-319, 2010. +
  88. + +
  89. M. Vdroljak +
    + On Hashin-Shtrikman bounds for mixtures of two isotropic + materials + +
    + Nonlinear Analysis: Real world applications, vol. 11, pp. 4597-4606, 2010 +
  90. + +
  91. C. Weiler +
    + Stromfunktionsformulierung der + Navier-Stokes-Gleichungen und Methoden der + Druckrekonstruktion + +
    + Diploma Thesis, University of Heidelberg, Germany, 2010 +
  92. + +
  93. + T. Wick +
    + Monolithic Fluid-Structure Interaction Modelling for + a Long Axis Heart Valve Simulation + +
    + Preprint, IWR Heidelberg, Germany, 2010 +
  94. + +
  95. T. D. Young, R. Armiento +
    + Strategies for h-adaptive refinement for a + finite element treatment of harmonic oscillator + Schrödinger eigenproblem + +
    + Commun. Theor. Phys. (Beijing, China), vol. 53(6), + pp. 1017-1023, 2010. +
  96. + +
  97. + L. Zhu +
    + Robust a posteriori error estimation for discontinuous + Galerkin methods for convection-diffusion equations + +
    + Ph.D. thesis, University of British Columbia, 2010 +
  98. +
+ + +

Publications in 2009

+ + +
    +
  1. W. Bangerth, A. Joshi +
    + Adaptive finite element methods for nonlinear inverse + problems + +
    + Proceedings of the 2009 ACM Symposium on Applied Computing, 2009. +
  2. + +
  3. W. Bangerth, O. Kayser-Herold +
    + Data Structures and Requirements for hp Finite Element + Software + +
    + ACM Trans. Math. Softw., vol. 36, pp. 4/1-31, 2009. +
  4. + +
  5. S. Bartle +
    + Shell finite elements with applications in biomechanics +
    + M.Sc. thesis, University of Cape Town, South Africa, 2009. +
  6. + +
  7. + F. Bassi, C. De Bartolo, R. Hartmann, A. Nigro +
    + A discontinuous Galerkin method for inviscid low Mach number flows + +
    + J. Comput. Phys., vol. 228, no. 11, pp. 3996-4011, 2009. +
  8. + +
  9. B. Brendel, T. Nielsen +
    + Selection of optimal wavelengths for spectral reconstruction + in diffuse optical tomography +
    + J. Biomed. Optics, vol. 14, 034041/1-034041/10, 2009. +
  10. + +
  11. C. Clason, P. Hepperger +
    + A forward approach to numerical data assimilation +
    + SIAM J. Sc. Comput., vol. 31, pp. 3090-3115, 2009 +
  12. + +
  13. B. Cockburn, G. Kanschat, and D. Schötzau +
    + An equal-order DG method for the incompressible Navier-Stokes + equations +
    + J. Sci. Comput., vol. 40, pp. 188-210, 2009. + DOI: 10.1007/s10915-008-9261-1 +
  14. + +
  15. A. DeSimone, L. Heltai, C. Manigrasso +
    + Tools for the Solution of PDEs Defined on + Curved Manifolds with the deal.II Library + +
    + Prep. SISSA 42/2009/M. +
  16. + +
  17. + F. Freddi, G. Royer-Carfagni +
    + From Non-Linear Elasticity to Linearized Theory: + Examples Defying Intuition + +
    + J. of Elasticity, vol. 96, pp. 1-26, 2009 +
    + +
  18. + P. Ghysels, G. Samaey, B. Tijskens, P. Van Liedekerke, + H. Ramon, D. Roose +
    + Multi-scale simulation of plant tissue deformation + using a model for individual cell mechanics + +
    + Phys. Biol., vol. 6, pp. 016009/1-14, 2009 +
    + +
  19. + S. Gladkov, M. Stiemer, B. Svendsen +
    + Phase-field-based modeling and simulation of solidification + and deformation behavior of technological alloys + +
    + PAMM, vol. 8, pp. 10547-10548, 2009 +
    + +
  20. R. Hartmann, M. Lukacova-Medvidova, F. Prill +
    + Efficient preconditioning for the discontinuous + Galerkin finite element method by low-order elements +
    + Appl. Numer. Math., vol. 59, no. 8, pp. 1737-1753, 2009 +
  21. + +
  22. H. K. Hesse, + G. Kanschat +
    + Mesh Adaptive Multiple Shooting for Partial Differential + Equations. Part I: Linear Quadratic Optimal Control Problems +
    + Journal of Numerical Mathematics, vol. 17, pp. 195-217 2009 +
  23. + +
  24. D. Hyde, R. Schulz, D. Brooks, E. Miller, V. Ntziachristos +
    + Performance dependence of hybrid x-ray computed + tomography/fluorescence molecular tomography on the optical + forward problem +
    + J. Optical Soc. Amer., vol. 26, pp. 919-923, 2009 +
  25. + +
  26. T. Jetzfellner, D. Razansky, A. Rosenthal, R. Schulz, + K.-H. Englmeier, V. Ntziachristos +
    + Performance of iterative optoacoustic tomography with + experimental data +
    + Appl. Phys. Lett., vol. 95, pp. 013703/1-3, 2009 +
  27. + +
  28. J. Jung +
    + Mehrgitterverfahren für FE-Modelle 4. Ordnung + +
    + Master's thesis, Universität Siegen, Germany, 2009 +
  29. + +
  30. + S. Kim +
    + Analysis of a PML method applied to computation of + resonances in open systems and acoustic scattering problems +
    + Ph.D. thesis, Texas A&M University, 2009 +
  31. + +
  32. + S. Kim, J. E. Pasciak +
    + The computation of resonances in open systems using a + perfectly matched layer +
    + Math. Comp., vol. 78, pp. 1375-1398, 2009 +
  33. + +
  34. N. Klein +
    + Modelladaptive FE-Techniken bei Elastizitätsproblemen + mit großen Verformungen + +
    + Master's thesis, Universität Siegen, Germany, 2009 +
  35. + +
  36. J. Lorentzon +
    + Fluid-structure interaction (FSI) case study of a cantilever + using OpenFOAM and DEAL.II with application to VIV + +
    + Master's thesis, Lunds Institute of Technology, Sweden, 2009 +
  37. + +
  38. + G. Matthies, G. Lube, L. Röhe +
    + Some remarks on streamline-diffusion methods for inf-sup + stable discretisations of the generalised Oseen problem + +
    + Comp. Meths. Appl. Math. 9 (2009) 4, 1-23. +
  39. + +
  40. A. M. McMahon +
    + Modelling the Flow Behaviour of Gas Bubbles in a + Bubble Column +
    + M.Sc. thesis, University of Cape Town, South Africa, 2009. +
  41. + +
  42. + S. T. Miller, F. Costanzo +
    + A numerical verification for an unconditionally + stable FEM for elastodynamics +
    + Comp. Mech., vol. 43, pp. 223-237, 2009 +
  43. + +
  44. + M. Olshanskii, G. Lube, T. Heister, J. Löwe +
    + Grad-div stabilization and subgrid pressure models for the + incompressible Navier–Stokes equations +
    + Comp. Meth. Appl. Mech. Eng. V. 198, pp. 3975-3988, 2009 +
  45. + +
  46. + J. S. Pitt, F. Costanzo +
    + An adaptive h-refinement algorithm for local damage + models +
    + Algorithms, vol. 2, pp. 1281-1300, 2009 +
  47. + +
  48. + L. Plagne, F. Hülsemann, D. Barthou, J. Jaeger +
    + Parallel expression template for large vectors + +
    + Proceedings of the 8th workshop on Parallel/High-Performance + Object-Oriented Scientific Computing, European Conference on + Object-Oriented Programming, 2009. +
  49. + +
  50. F. Prill, M. Lukacova-Medvidova, + R. Hartmann +
    + Smoothed aggregation multigrid for the discontinuous + Galerkin method + +
    + SIAM J. Sci. Comput., vol. 31, no. 5, pp. 3503-3528, 2009. +
  51. + +
  52. + F. Prill, M. Lukacova-Medvidova, + R. Hartmann +
    + A multilevel discontinuous Galerkin method for the + compressible Navier-Stokes equations + +
    + In A. Handlovicova, P. Frolkovic, K. Mikula and D. Sevcovic, eds., + Proceedings of ALGORITMY 2009. 18th Conference on Scientific + Computing Vysoke Tatry - Podbanske, Slovakia, March 15 - 20, + 2009. +
  53. + +
  54. + A. Q. Raeini +
    + Fractured reservoir simulation using finite element method + with logarithmic shape functions (in Persian) + +
    + M. Sc. thesis, Sharif University of Technology, Iran, 2009. +
  55. + +
  56. + H. R. Ramay and M. Vendelin +
    + Diffusion restrictions surrounding mitochondria: a + mathematical model of heart muscle fibers + +
    + Biophys. J., vol. 97, pp. 443-452, 2009. +
  57. + +
  58. + R. Rannacher +
    + Adaptive Finite Element Discretization of Flow + Problems for Goal-Oriented Model Reduction +
    + In: Computational Fluid Dynamics 2008 (H. Choi, H. + G. Choi and J. Y. Yoo, eds.), pp. 31-45, Springer, 2009. +
  59. + +
  60. + D. Schötzau, L. Zhu +
    + A robust a-posteriori error estimator for discontinuous + Galerkin methods for convection-diffusion equations + +
    + Appl. Numer. Math., vol. 59, pp. 2236-2255, 2009 +
  61. + +
  62. N. Schröder +
    + Simulation eines mikrofluidischen Kanals mit deal.II + +
    + Master's thesis, Universität Siegen, Germany, 2009 +
  63. + +
  64. Y. Wang +
    + Adaptive mesh refinement solution techniques for the + multigrid SN transport equation using a + higher-order discontinuous finite element method + +
    + Ph.D. thesis, Texas A&M University, 2009 +
  65. + +
  66. Y. Wang, W. Bangerth, J. Ragusa +
    + Three-dimensional h-adaptivity for the multigroup neutron + diffusion equations + +
    + Progress in Nuclear Energy, vol. 51, pp. 543-555, 2009 +
  67. + +
  68. S. Wanka +
    + Grundkonzepte zur Modelladaptivität bei Hindernisproblemen + +
    + Master's thesis, Universität Siegen, Germany, 2009 +
  69. + +
  70. J. White +
    + Stabilized finite element methods for coupled flow + and geomechanics +
    + PhD thesis, Stanford University, 2009. +
  71. + +
  72. J. Willems +
    + Numerical Upscaling for Multiscale Flow Problems - Analysis + and Algorithms +
    + Südwestdeutscher Verlag für Hochschulschriften, 2009. +
  73. + +
  74. J. Willems +
    + Numerical upscaling for multiscale flow problems + +
    + Ph.D. thesis, University of Kaiserslautern, Germany, 2009 +
  75. + +
  76. T. D. Young, E. Romero, and J. E. Roman +
    + Finite element solution of the stationary + Schrödinger equation using standard computational tools + +
    + In Proceedings of the International Conference on + Computational and Mathematical Methods in Science and + Engineering 2009, Gijon Asturias, Spain, July + 2009. +
  77. + +
  78. T. D. Young +
    + Exemplifying quantum systems in a finite element + basis + +
    + In George Maroulis and Theodore E. Simos, editors, + Computational Methods in Science and Engineering: Advances in + Computational Science, number 1108, New York, USA, Mar + 2009. Proceedings of the International Conference on Computational + Methods in Sciences and Engineering, American Institute of Physics + Conference Proceedings, 2009. +
  79. + +
  80. R. Ziegler, B. Brendel, A. Schipper, R. Harbers, M. van Beek, + H. Rinneberg, T. Nielsen +
    + Investigation of detection limits for diffuse optical + tomography systems: I. Theory and experiment + +
    + Phys. Med. Biol., vol. 54, pp. 399-412, 2009 +
  81. + +
  82. R. Ziegler, B. Brendel, + H. Rinneberg, T. Nielsen +
    + Investigation of detection limits for diffuse optical + tomography systems: II. Analysis of slab and cup geometry for + breast imaging + +
    + Phys. Med. Biol., vol. 54, pp. 413-431, 2009 +
  83. + +
  84. R. Ziegler, T. Nielsen, T. Koehler, D. Grosnick, + O. Steinkellner, A. Hagen, R. Macdonald, H. Rinneberg +
    + Nonlinear reconstruction of absorption and + fluorescence contrast from measured diffuse transmittance and + reflectance of a compressed-breast-simulating phantom + +
    + Applied Optics, vol. 48, pp. 4651-4662, 2009 +
  85. +
+ + + + +

Publications in 2008

+ + +
    +
  1. W. Bangerth +
    + A framework for the adaptive finite element solution of + large-scale inverse problems + +
    + SIAM J. Sci. Comput, vol. 30, pp. 2965-2989, 2008 +
  2. + +
  3. W. Bangerth, A. Joshi +
    + Adaptive finite element methods for the solution of + inverse problems in optical tomography + +
    + Inverse Problems, vol. 24, article 034011 (23 pages), 2008 +
  4. + +
  5. E. Bängtsson, B. Lund +
    + A comparison between two solution techniques to solve + the equations of glacially induced deformation of an elastic + Earth + +
    + Int. J. Numer. Meth. Engrg., vol. 75, pp. 479-502, 2008 +
  6. + +
  7. + M. Bartels, A. Joshi, J. C. Rasmussen, E. M. Sevick-Muraca, + W. Bangerth +
    + Post-image acquisition excitation light mitigation in NIR + fluorescent tomography + +
    + Proceedings of the IEEE International + Symposium on Biomedical Imaging, Arlington, VA, 2008 +
  8. + +
  9. + B. Brendel, R. Ziegler, T. Nielsen +
    + Algebraic reconstruction techniques for spectral + reconstruction in diffuse optical tomography + +
    + Applied Optics, vol. 47, pp. 6392-6403, 2008 +
  10. + +
  11. D. Boffi, L. Gastaldi, L. Heltai, + C. S. Peskin +
    + On the hyper-elastic formulation of + the immersed boundary method + +
    + Computer Methods in Applied Mechanics and Engineering, + vol. 197, pp. 2210-2231, 2008 +
  12. + +
  13. B. Carnes, G. F. Carey +
    + Local boundary value problems for the error in FE + approximation of non-linear diffusion systems + +
    + Int. J. for Numer. Methods Engrg., vol. 73, + pp. 665-684, 2008 +
  14. + +
  15. N. Djilali, P. C. Sui +
    + Transport phenomena in fuel cells: from microscale to + macroscale + +
    + Int. J. of Comput. Fluid Dynam., vol. 22, + pp. 115-133, 2008 +
  16. + +
  17. R. Fosdick, F. Freddi, G. Royer-Carfagni +
    + Bifurcation instability in + linear elasticity with the constraint of local injectivity + +
    + J. of Elasticity, vol. 90, pp. 99-126, 2008 +
  18. + +
  19. + M. Geiger +
    + Vergleich dreier Zeitschrittverahren zur numerischen + Lösung der akustischen Wellengleichung +
    + Diploma thesis, University of Heidelberg, Germany, 2008 +
  20. + +
  21. + P. Ghysels, G. Samaey, B. Tijskens, + H. Ramon, D. Roose +
    + Multi-scale simulation of plant tissue deformation + using a model for individual cell behavior + +
    + Report TW 522, Department of Computer Science, K.U. Leuven, Belgium, + 2008 +
    + +
  22. C. Giavarini, M. L. Santarelli, R. Natalini, F. Freddi +
    + A non linear model of + sulphation of porous stones: numerical simulations and preliminary + laboratory assessments + +
    + J. of Cultural Heritage, vol. 9, pp. 14-22, 2008 +
  23. + +
  24. M. Grote, A. + Schneebeli, D. Schötzau +
    + Interior penalty discontinuous Galerkin method for + Maxwell's equations: optimal L2-norm estimates + +
    + IMA J. Numer. Anal., vol. 28, pp. 440-468, 2008 +
  25. + +
  26. + R. Hartmann +
    + Multitarget error estimation and adaptivity in aerodynamic flow simulations + +
    + SIAM J. Sci. Comput., vol. 31, no. 1, pp. 708-731, 2008 +
  27. + +
  28. + R. Hartmann +
    + Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods +
    + In H. Deconinck, editor, + VKI LS 2008-08: 35th CFD/ADIGMA course on very high order discretization methods, Oct. 13-17, 2008. +
    + Von Karman Institute for Fluid Dynamics, Rhode Saint Genese, Belgium (2008). +
  29. + +
  30. + R. Hartmann, P. Houston +
    + An optimal order interior penalty discontinuous + Galerkin discretization of the compressible Navier-Stokes + equations + +
    + J. Comput. Phys., vol. 227, no. 22, pp. 9670-9685, 2008 +
  31. + +
  32. + T. Heister +
    + Vorkonditionierunsstrategien für das + stabilisierte Oseen-Problem +
    + Diploma thesis, University of Göttingen, Germany, 2008 +
  33. + +
  34. L. Heltai +
    + On the stability of the finite element immersed + boundary method +
    + Computers and Structures, vol. 86, pp. 598-617, 2008 +
  35. + +
  36. A. Joshi, W. Bangerth, E. Sevick +
    + Non-Contact Fluorescence Optical Tomography with + Adaptive Finite Element Methods + +
    + In: "Mathematical Methods in Biomedical Imaging and Intensity-Modulated + Radiation Therapy (IMRT)", Y. Censor, M. Jiang and A.K. Louis (eds.), + pp. 185-200, + Birkhäuser, 2008 +
  37. + +
  38. + G. Kanschat +
    + Robust smoothers for high order discontinuous Galerkin + discretizations of advection-diffusion problems +
    + J. Comput. Appl. Math., vol. 218, pp. 53-60, 2008. +
    + (Preprint) +
  39. + +
  40. G. Kanschat, D. Schötzau +
    + Energy norm a-posteriori error estimation for divergence-free + discontinuous Galerkin approximations of the Navier-Stokes + equations + +
    + Int. J. Numer. Methods Fluids, vol. 57, pp. 1093-1113, 2008. + DOI: 10.1002/fld.1795 +
  41. + +
  42. D. K. Khalmanova, F. Costanzo +
    + A space-time discontinuous Galerkin finite element method for + fully coupled linear thermo-elasto-dynamic problems with strain and + heat flux discontinuities + +
    + Comput. Meth. Appl. Mech. Engrg., vol. 197, pp. 1323-1342, 2008 +
  43. + +
  44. L. Khasina +
    + Mathematische Behandlung von Mischungen + elastoplastischer Substanzen + +
    + PhD thesis, University of Bonn, Germany, 2008 +
  45. + +
  46. M. Kronbichler, G. Kreiss +
    + A hybrid level–set–Cahn–Hilliard model for + two-phase flow + +
    + Proceedings of the 1st European Conference on Microfluidics, accepted + for publication. Microfluidics 2008, Bologna, Italy, December + 10–12, 2008. +
  47. + +
  48. + T. Leicht, R. Hartmann +
    + Anisotropic mesh refinement for discontinuous Galerkin methods + in two-dimensional aerodynamic flow simulations + +
    + Int. J. Numer. Meth. Fluids, vol. 56, no. 11, pp. 2111-2138, 2008 +
  49. + +
  50. + J. Löwe +
    + Stabilisierung durch lokale Projektion für + inkompressible Strömungsprobleme +
    + Diploma thesis, University of Göttingen, Germany, 2008 +
  51. + +
  52. + M. Neytcheva and E. Bängtsson +
    + Preconditioning of nonsymmetric saddle point systems as + arising in modelling of viscoelastic problems +
    + ETNA, vol. 29, pp. 193-211, 2008 + 2008 +
  53. + +
  54. + J. S. Pitt, F. Costanzo +
    + Theory and simulation of a brittle damage model in + thermoelastodynamics +
    + Proceedings of the 8th World Congress on Computational + Mechanics (WCCM 8), Venice, Italy, 2008 +
  55. + +
  56. + K. Schmid +
    + Theory and numerics of a reconstruction algorithm for a + problem from acoustic microscopy +
    + Diploma thesis, Technical University of Munich, Germany, + 2008 +
  57. + +
  58. M. Secanell, K. Karan, A. Suleman, N. Djilali +
    + Optimal design of ultralow-platinum PEMFC anode electrodes + +
    + Journal of The Electrochemical Society, vol. 155, pp. B125-B134, 2008 +
  59. + +
  60. M. Secanell, R. Songprakorp, A. Suleman, N. Djilali +
    + Multi-objective optimization of a polymer electrolyte + fuel cell membrane electrode assembly + +
    + Energy & Environmental Science, vol. 1, pp. 378-388, 2008 +
  61. + +
  62. J. A. White, R. I. Borja +
    + Stabilized low-order finite elements for coupled + solid-deformation/fluid-diffusion and their application to + fault zone transients + +
    + Comput. Meth. Appl. Mech. Engrg., vol. 197, pp. 4353-4366, 2008 +
  63. + +
  64. T. Wick +
    + Untersuchung von Kopplungsmechanismen von + Fluid-Struktur-Interaktion + +
    + Master's thesis, Universität Siegen, Germany, 2008 +
  65. +
+ + + +

Publications in 2007

+ +
    +
  1. N. Antonic, M. Vrdoljak +
    + Gradient methods for multiple state optimal design problems + +
    + Ann. Univ. Ferrara, vol. 53, pp. 177-187, 2007 +
  2. + +
  3. + P. F. Antonietti, + L. Heltai +
    + Numerical validation of a class of mixed + discontinuous Galerkin methods for Darcy flow + +
    + Computer Methods in Applied Mechanics and Engineering, + vol. 196, pp. 4505-4520, 2007 +
  4. + +
  5. W. Bangerth, + R. Hartmann, + G. Kanschat +
    + deal.II — a general-purpose object-oriented finite + element library + +
    + ACM Transactions on Mathematical Software, vol. 33, no. 4, article + 24, 2007 +
  6. + +
  7. W. Bangerth, A. Joshi, E. Sevick +
    + Inverse biomedical imaging using separately adapted meshes + for parameters and forward model variables + +
    + Proceedings of the IEEE International Symposium on Biomedical Imaging, + Arlington, VA, pp. 1368-1371, 2007 +
  8. + +
  9. E. Bängtsson, M. Neytcheva +
    + Finite Element Block-Factorized Preconditioners + +
    + Technical Report 2007-008, Uppsala University, Sweden, 2007 +
  10. + +
  11. D. Boffi, L. Gastaldi, L. Heltai +
    + On the CFL condition for the finite element immersed + boundary method +
    + Computers & Structures, vol. 85, pp. 775-783, 2007 + (DOI) +
  12. + +
  13. D. Boffi, L. Gastaldi, L. Heltai +
    + Numerical stability of the finite element immersed boundary method +
    + Mathematical Models and Methods in Applied Sciences, vol. 17, + pp. 1479-1505, 2007 +
  14. + +
  15. M. Calhoun-Lopez, M. D. Gunzburger +
    + The efficient implementation of a finite element, + multi-resolution viscosity method for hyperbolic conservation + laws + +
    + Journal of Computational Physics, vol. 225, pp. 1288-1313, 2007 +
  16. + +
  17. B. Carnes, G. F. Carey +
    + Estimating spatial and parameter error in + parameterized nonlinear reaction-diffusion equations + +
    + Communications in Numerical Methods in Engineering, vol. 23, + pp. 835-854, 2007 +
  18. + + +
  19. C. C. Douglas, M. J. Cole, P. Dostert, Y. Efendiev, R. E. Ewing, + G. Haase, J. Hatcher, M. Iskandarani, C. R. Johnson, R. A. Lodder +
    + Dynamically identifying and tracking contaminants in water + bodies + +
    + International Conference on Computational Science ICCS 2007, + vol. 4487 of Springer Lecture Notes in Computer Science, + pp. 1002-1009, 2007 +
  20. + +
  21. F. Freddi, M. Frémond +
    + Collision and Fractures: a predictive theory + +
    + Proceedings of the EuroSim Conference, Lubiana, Slovenia, + 9-13 September, 2007 +
  22. + +
  23. P.K. Galenko, S. Reutzel, D. M. Herlach, D. Danilov, B. Nestler +
    + Modelling of dendritic solidification in undercooled + dilute Ni-Zr melts + +
    + Acta Materialia, vol. 55, pp. 6834-6842, 2007 +
  24. + +
  25. A. Garny, J. Cooper, P. J. Hunt +
    + Toward a VPH/Physiome ToolKit + +
    + Wiley Interdisciplinary Reviews: Systems Biology and Medicine, + vol. 2, pp. 134-147, 2010 +
  26. + +
  27. T. Ha, C. Shin +
    + Magnetotelluric inversion via reverse time migration + algorithm of seimic data + +
    + J. Comput. Phys., vol. 225, pp. 237-262, 2007 +
  28. + +
  29. + R. Hartmann +
    + Adjoint consistency analysis of Discontinuous Galerkin discretizations + +
    + SIAM J. Numer. Anal., vol. 45, no. 6, pp. 2671-2696, 2007 +
  30. + +
  31. + R. Hartmann +
    + Error estimation and adjoint based refinement for an adjoint + consistent DG discretization of the compressible Euler equations + +
    + Int. J. Computing Science and Mathematics, vol. 1, pp. 207-220, 2007 +
  32. + +
  33. R. Hartmann +
    + DG discretizations for compressible flows: Adjoint + consistency analysis, error estimation and adaptivity + +
    + In R. Rannacher, E. Süli, and R. Verführt, eds., + Adaptive Numerical Methods for PDEs, Mathematisches + Forschungsinstitut Oberwolfach Report 29/2007, pp. 26-30, 2007 +
  34. + +
  35. P. Hepperger +
    + Ein POD-basierter Ansatz zur numerischen Lösung eines + Datenassimilationsproblems am Beispiel einer linearen + Diffusions-Konvektions-Gleichung +
    + Diploma thesis, Technical University of Munich, Germany, + 2007
  36. + +
  37. Christian D. Kamm +
    + A posteriori error estimation in numerical methods + for solving self-adjoint eigenvalue problems + +
    + Diploma thesis, TU Berlin, Germany, 2007 +
  38. + +
  39. O. Kayser-Herold, H.G. Matthies +
    + A unified least-squares formulation for fluid-structure interaction + problems + +
    + Computers and Structures, vol. 85, pp. 998-1011, 2007 +
  40. + +
  41. B. Janssen, +
    + Vergleich verschiedener Finite-Elemente-Approximationen + zur numerischen Lösung der Plattengleichung +
    + Diploma thesis, University of Heidelberg, Germany, 2007. +
  42. + +
  43. A. Joshi, W. Bangerth, R. Sharma, J. Rasmussen, W. Wang, + E. Sevick +
    + Molecular tomographic imaging of lymph nodes with + NIR fluorescence + +
    + Proceedings of the IEEE International Symposium on Biomedical Imaging, + Arlington, VA, pp. 564-567, 2007 +
  44. + +
  45. B. Nestler, D. Danilov, A. Bracchi, + Y.-L. Huang, T. Niermann, M. Seibt and S. Schneider +
    + A metallic glass composite: Phase-field simulations + and experimental analysis of microstructure evolution + +
    + Materials Science and Engineering: A, vol. 452-453, pp. 8-14, 2007 +
  46. + +
  47. + A. Nigro +
    + Discontinuous Galerkin Methods for inviscid low Mach + number flows +
    + Ph.D. thesis, University of Calabria, 2007 +
  48. + +
  49. P. J. Phillips and M. F. Wheeler +
    + A coupling of mixed and continuous Galerkin finite + element methods for poroelasticity II: the discrete-in-time case + +
    + Computational Geosciences, vol. 11, pp. 145-158, 2007 +
  50. + +
  51. H.-J. Reinhardt, D. N. Hào, J. Frohne and F.-T. Suttmeier +
    + Numerical solution of Inverse Heat Conduction + Problems in two spatial dimensions + +
    + J. Inverse and Ill-Posed Problems, vol. 5, pp. 19-36, 2007 +
  52. + +
  53. + L. Röhe +
    + Residuale Stabilisierung für Finite Elemente Verfahren + bei inkompressiblen Strömungen +
    + Diploma thesis, University of Göttingen, Germany, 2007 +
  54. + +
  55. M. Schmidt +
    + Systematic discretization of input/output maps and + other contributions to the control of distributed parameter + systems + +
    + Ph.D. thesis, TU Berlin, Germany, 2007 +
  56. + +
  57. M. Secanell, B. Carnes, A. Suleman, N. Djilali +
    + Numerical optimization of proton exchange membrane fuel cell + cathodes + +
    + Electrochimica Acta, vol. 52, pp. 2668-2682, 2007 +
  58. + +
  59. M. Secanell, K. Karan, A. Suleman, N. Djilali +
    + Multi-variable optimization of PEMFC cathodes using + an agglomerate model + +
    + Electrochimica Acta, vol. 52, pp. 6318-6337, 2007 +
  60. + +
  61. + M. Steigemann, M. Fulland, M. Specovius-Neugebauer, H. A. Richard +
    + Simulation of crack paths in functionally graded materials + +
    + PAMM, vol. 7, pp. 4030029-4030030, 2007 +
  62. + +
  63. M. Steigemann, M. Fulland +
    + On the computation of the pure Neumann problem in + 2-dimensional elasticity + +
    + International Journal of Fracture, vol. 146, pp. 265-277, 2007 +
  64. + +
  65. R. Ziegler, T. Nielsen, T. Koehler, D. Grosenick, + O. Steinkellner, A. Hagen, R. Macdonald, H. Rinneberg +
    + Reconstruction of absorption and fluorescence + contrast for scanning time-domain fluorescence mammography + +
    + Optical Tomography and Spectroscopy of Tissue VII, Proc. SPIE + vol. 6434, 64340H/1-11, 2007 +
  66. +
+ + + + +

Publications in 2006

+ +
    + +
  1. M. Allmaras +
    + Optimal Design of Periodic Microstructures by the + Inverse Homogenization Method + +
    + Diploma Thesis, Technical University Munich, Germany, 2006 +
  2. + +
  3. N. Antonic, M. Vrdoljak +
    + Sequential laminates in multiple state optimal design problems + +
    + Mathematical Problems in Engineering, vol. 2006, pp. 1-14, 2006 +
  4. + +
  5. + P. F. Antonietti +
    + Domain decomposition, spectral correctness and + numerical testing of discontinuous Galerkin methods + +
    + Ph.D. thesis, University of Pavia, Italy, 2007 +
  6. + +
  7. E. Bängtsson, B. Lund +
    + A comparison between two approaches to solve the equations of + isostasy + +
    + Institute for Parallel Processing (BIS 21++) Technical Report 2006-03, + Bulgarian Academy of Sciences, 2006 +
  8. + +
  9. E. Bängtsson, B. Lund +
    + A comparison between two approaches to solve the equations of + isostasy + +
    + Technical Report 2006-051, Uppsala University, Sweden, 2006 +
  10. + +
  11. E. Bängtsson, M. Neytcheva +
    + Numerical simulations of glacial rebound using + preconditioned iterative solution methods + +
    + Applications of Mathematics, vol. 50, pp. 183-201, 2006 +
  12. + +
  13. E. Bängtsson, M. Neytcheva +
    + An agglomerate multilevel preconditioner for linear + isostasy saddle point problems + +
    + Proceedings of Large-Scale Scientific Computing: 5th + International Conference (I. Lirkov, S. Margenov, + J. Wasniewski, eds), pp. 113-120, 2006 +
  14. + +
  15. B. Carnes, N. Djilali +
    + Analysis of coupled proton and water transport in a + PEM fuel cell using the binary friction membrane model + +
    + Electrochimica Acta, vol. 52, pp. 1038-1052, 2007 +
  16. + +
  17. D. Danilov, B. Nestler +
    + Phase-field simulations of eutectic solidification + using an adaptive finite element method + +
    + International Journal of Modern Physics B, vol. 20, + pp. 853-867, 2006 +
  18. + +
  19. J. Frohne +
    + Numerische Lösung des inversen + Wärmeleitproblems in zwei + Ortsdimensionen zur Identifizierung von Randbedingungen + +
    + Diploma thesis, Universität Siegen, Germany, 2009 +
  20. + +
  21. M. Grote, A. + Schneebeli, D. Schötzau +
    + Discontinuous Galerkin Finite Element Method for the Wave Equation + +
    + SIAM J. Numer. Anal, vol. 44, pp. 2408-2431, 2006 +
  22. + +
  23. T. Ha, C. Shin +
    + Two dimensional magnetotelluric inversion via reverse + time migration algorithm + +
    + Abstracts of the SEG Annual Meeting in New Orleans, + pp. 830-835, 2006 +
  24. + +
  25. + R. Hartmann +
    + Error estimation and adjoint-based adaptation in aerodynamics + +
    + In P. Wesseling, E. Onate, J. Periaux, eds., + Proceedings of the ECCOMAS CFD 2006, Sept. 5-8, Egmond aan Zee, + The Netherlands, 2006 +
  26. + + +
  27. + R. Hartmann +
    + Derivation of an adjoint consistent discontinuous Galerkin + discretization of the compressible Euler equations + +
    + In G. Lube and G. Rapin, eds., + Proceedings of the BAIL 2006 Conference, 2006 +
  28. + + +
  29. + R. Hartmann +
    + Adaptive discontinuous Galerkin methods with + shock-capturing for the compressible Navier-Stokes equations + +
    + Int. J. Numer. Meth. Fluids, vol. 51, pp. 1131-1156, 2006 +
  30. + +
  31. + R. Hartmann, P. Houston +
    + Symmetric Interior Penalty DG Methods for the + Compressible Navier-Stokes Equations I: Method Formulation + +
    + Int. J. Numer. Anal. Model., vol. 3, pp. 1-20, 2006. +
  32. + + +
  33. R. Hartmann, P. Houston +
    + Symmetric Interior Penalty DG Methods for the + Compressible Navier-Stokes Equations II: Goal-Oriented A + Posteriori Error Estimation + +
    + Int. J. Numer. Anal. Model., vol. 3, pp. 141-162, 2006 +
  34. + +
  35. L. Heltai +
    + The Finite Element Immersed Boundary Method +
    + Ph.D. thesis, Università di Pavia, Dipartimento di Matematica "F. Casorati", + 2006 +
  36. + +
  37. K. Hwang, T. Pan, A. Joshi, J. C. Rasmussen, W. Bangerth, + E. Sevick-Muraca +
    + Influence of excitation light rejection on forward model + mismatch in optical tomography + +
    + Phys. Med. Biol., vol. 51, pp. 5889-5902, 2006 +
  38. + +
  39. A. Joshi, W. Bangerth, E. Sevick-Muraca +
    + Non-contact fluorescence optical tomography with scanning + patterned illumination + +
    + Optics Express, vol. 14, + pp. 6516-6534, 2006 +
  40. + +
  41. A. Joshi, W. Bangerth, K. Hwang, J. C. Rasmussen, + E. Sevick-Muraca +
    + Fully adaptive FEM based fluorescence optical tomography from + time-dependent measurements with area illumination and detection + +
    + Med. Phys., vol. 33, + pp. 1299-1310, 2006 +
  42. + +
  43. A. Joshi, W. Bangerth, E. Sevick-Muraca +
    + Non-contact fluorescence optical tomography with scanning + illumination + +
    + Proceedings of the IEEE International Symposium on Biomedical Imaging, + Arlington, VA, 2006, pp. 582-585, 2006 +
  44. + +
  45. A. Joshi, W. Bangerth, K. Hwang, J. C. Rasmussen, + E. Sevick-Muraca +
    + Plane wave fluorescence tomography with adaptive finite + elements + +
    + Optics Letters, vol. 31, + pp. 193-195, 2006 +
  46. + +
  47. O. Kayser-Herold +
    + Least-Squares Methods for the Solution of Fluid-Structure + Interaction Problems + +
    + Ph.D. thesis, TU-Braunschweig, Germany, 2006 +
    + Available online through this link +
  48. + +
  49. + T. Leicht +
    + Anisotropic Mesh Refinement for Discontinuous Galerkin + Methods in Aerodynamic Flow Simulations + +
    + Diploma thesis, TU Dresden, 2006 +
    + Available online through this link +
  50. + +
  51. D. Oeltz +
    + Ein Raum-Zeit Dünngitterverfahren zur Diskretisierung + parabolischer Differentialgleichungen + +
    + Ph.D. thesis, University of Bonn, Germany, 2006 +
  52. + +
  53. M. Schmidt +
    + Low-dimensional I/O modeling of distributed parameter + systems + +
    + Proc. Appl. Math. Mech., vol. 6, pp. 15-18, 2006 +
  54. + +
+ + + +

Publications in 2005

+ +
    + +
  1. M. Anderson, W. Bangerth, G. Carey +
    + Analysis of parameter sensitivity and experimental + design for a class of nonlinear partial differential + equations + +
    + International Journal for Numerical Methods in Fluids, vol. 48, + pp. 583-605, 2005 +
  2. + +
  3. W. Bangerth, A. Joshi, E. Sevick-Muraca +
    + Adaptive finite element methods for increased + resolution in fluorescence optical tomography + +
    + Progress in Biomedical Optics and Imaging, vol. 6, + pp. 318-329, 2005 +
  4. + +
  5. D. Boffi, L. Gastaldi, L. Heltai +
    + The finite element immersed boundary method: model, stability, and numerical + results +
    + In Schrefler Papadrakakis, Onate, eds., Computational Methods for + Coupled Problems in Science and Engineering, 2005 +
  6. + +
  7. D. Boffi, L. Gastaldi, L. Heltai +
    + Stability results and algorithmic strategies for the finite + element approach to the immersed boundary method + +
    + Proceeding of the Sixth European Conference on Numerical Mathematics + and Advanced Applications (ENUMATH 2005), pages 557-566, 2005 +
  8. + +
  9. M. Calhoun-Lopez, M. D. Gunzburger +
    + A Finite Element, Multiresolution Viscosity Method + for Hyperbolic Conservation Laws + +
    + SIAM J. Numer. Anal., vol. 43, pp. 1988-2011, 2005 +
  10. + +
  11. B. Carnes, N. Djilali +
    + Systematic parameter estimation for PEM fuel cell models + +
    + Journal of Power Sources, vol. 144, pp. 83-93, 2005 +
  12. + +
  13. + B. Cockburn, + G. Kanschat, + D. Schötzau +
    + A locally conservative LDG method for the incompressible Navier- Stokes equations +
    + Math. Comput., vol. 74, pp. 1067-1095, 2005 +
  14. + +
  15. + B. Cockburn, + G. Kanschat, + D. Schötzau +
    + The Local Discontinuous Galerkin Method for Linear + Incomressible Fluid Flow: a Review +
    + Comput. & Fluids, vol. 34, pp. 491-506, 2005 +
  16. + +
  17. + R. Hartmann +
    + Discontinuous Galerkin methods for compressible flows: + higher order accuracy, error estimation and adaptivity + +
    + In H. Deconinck and M. Ricchiuto, editors, + VKI LS 2006-01: CFD - Higher Order Discretization Methods, + November 14-18, 2005, Rhode Saint Genese, Belgium. +
    + von Karman Institute for Fluid Dynamics (2005) +
  18. + +
  19. A. Joshi +
    + Adaptive finite element methods for fluorescence enhanced + optical tomography + +
    + Ph.D. thesis, Texas A&M University, 2005 +
  20. + +
  21. A. Joshi, W. Bangerth, A. B. Thompson, E. Sevick-Muraca +
    + Experimental fluorescence optical tomography using + adaptive finite elements and planar illumination with + modulated excitation light + +
    + Progress in Biomedical Optics and Imaging, vol. 6, + pp. 351-358, 2005 +
  22. + +
  23. + G. Kanschat +
    + Block Preconditioners for LDG Discretizations of + Linear Incompressible Flow Problems +
    + J. Sci. Comput., vol. 22, pp. 381-394, 2005 +
  24. + +
  25. O. Kayser-Herold, H. G. Matthies +
    + Least squares finite element methods for fluid-structure + interaction problems + +
    + Computers & Structures, vol. 83, pp. 191-207, 2005 +
  26. + +
  27. R. Li +
    + On multi-mesh h-adaptive methods +
    + J. Sci. Comput., vol. 24, pp. 321-341, 2005 +
    + (This paper uses AFEPack which in turn uses deal.II's linear + algebra library.) +
  28. + +
  29. M. Mu +
    + PDE.MART: A network-based problem-solving environment + for PDEs + +
    + ACM Trans. Math. Software, vol. 31, pp. 508-531, 2005 +
  30. + +
  31. B. Nestler, D. Danilov, P. Galenko +
    + Crystal growth of pure substances: Phase-field simulations in + comparison with analytical and experimental results + +
    + Journal of Computational Physics, vol. 207, pp. 221-239, 2005 +
  32. + +
  33. T. Nielsen, T. Koehler, M. van der Mark, G. t'Hooft +
    + Fully 3D reconstruction of attenuation for diffuse + optical tomography using a finite element model + +
    + Nuclear Science Symposium Record, vol. 4, pp. 2283-2285, 2005 +
  34. + +
  35. Q. Ouyang, K. Xiu +
    + Simulation Study of Reduced Self-Heating in Novel + Thin-SOI Vertical Bipolar Transistors + +
    + Simulation of Semiconductor Processes and Devices, pp. 55-58, 2005 +
  36. + +
  37. M. Polner +
    + Galerkin least-squares stabilization operators for the + Navier-Stokes equations, A unified approach + +
    + Ph.D. thesis, University of Twente, The Netherlands, 2005 +
  38. + +
  39. R. B. Schulz, G. Echner, H. Ruehle, + W. Stroh, J. Vierling, T. Vogt, J. Peter, W. Semmler +
    + Development of a fully rotational non-contact fluorescence tomographer + for small animals + +
    + IEEE Micro-imaging Conference, IEEE Nuclear Science Symposium + Conference Record, pp. 2391-2393, 2005 +
  40. + + +
  41. R. B. Schulz, J. Peter, W. Semmler, C. D'andrea, G. Valentini, R. Cubeddu +
    + Quantifiability and Image Quality in Noncontact Fluorescence Tomography + +
    + in: Photon Migration and Diffuse-Light Imaging II, K. Licha + and R. Cubeddu (eds.), SPIE press, 2005 +
  42. + +
+ + + + +

Publications in 2004

+ +
    +
  1. W. Bangerth, +
    + A framework for the adaptive finite element solution + of large inverse problems. I. Basic techniques + +
    + ICES Report 2004-39, 2004. +
  2. + +
  3. W. Bangerth, M. Grote, C. Hohenegger +
    + Finite Element Method For Time Dependent Scattering: + Nonreflecting Boundary Condition, Adaptivity, and Energy + Decay + +
    + Computer Methods in Applied Mechanics and Engineering, + vol. 193, pp. 2453-2482, 2004 +
  4. + +
  5. D. Boffi, L. Gastaldi, L. Heltai +
    + A finite element approach to the immersed boundary method + +
    + Progress in Engineering Computational Technology, vol. 12, + pp. 271-298, 2004 +
  6. + + +
  7. G. Carey, M. Anderson, B. Carnes, B. Kirk +
    + Some aspects of adaptive grid technology related to + boundary and interior layers + +
    + Journal of Computational and Applied Mathematics, vol. 166, + pp. 55-86, 2004 +
  8. + +
  9. G. Carey, W. Barth, J. A. Woods, B. Kirk, + M. Anderson, S. Chow, W. Bangerth +
    + Modeling error and constitutive relations in + simulation of flow and transport + +
    + International Journal for Numerical Methods in Fluids, + vol. 46, pp. 1211-1236, 2004 +
  10. + +
  11. S. Chow, G. F. Carey, M. L. Anderson +
    + Finite element approximations of a glaciology problem. + +
    + ESAIM: Mathematical Modelling and Numerical Analysis (M2AN), + vol. 38, pp. 741-756, 2004. +
  12. + +
  13. R. Hartmann, P. Houston +
    + Goal-Oriented A Posteriori Error Estimation + for Multiple Target Functionals + +
    + in M. Feistauer, V. Doleji, P. Knobloch and K. Najzar, + editors, Numerical Mathematics and Advanced Applications, + ENUMATH 2003, pp. 410-419, Springer-Verlag, 2004 +
    + (BibTeX entry) +
  14. + +
  15. U. Hasler, A. + Schneebeli, D. + Schötzau +
    + Mixed finite element approximation of incompressible + MHD problems based on weighted regularization + +
    + Applied Numerical Mathematics, vol. 51, pp. 19-45, 2004 +
  16. + +
  17. A. Joshi, W. Bangerth, E. Sevick-Muraca +
    + Adaptive finite element modeling of optical + fluorescence-enhanced tomography + +
    + Optics Express, vol. 12, pp. 5402-5417, 2004 +
  18. + +
  19. A. Joshi, A. B. Thompson, W. Bangerth, E. Sevick-Muraca +
    + Adaptive finite element methods for forward modeling + in fluorescence enhanced frequency domain optical tomography + +
    + Proceedings of the 2004 OSA Biomedical Topical Meetings, 2004 +
  20. + +
  21. A. Joshi, W. Bangerth, A. B. Thompson, E. Sevick-Muraca +
    + Adaptive finite element methods for fluorescence + enhanced frequency domain optical tomography: Forward imaging + problem + +
    + Proceedings of the 2004 IEEE International Symposium on + Biomedical Imaging, 2004 +
  22. + +
  23. + G. Kanschat +
    + Multi-level methods for discontinuous Galerkin FEM on locally refined meshes +
    + Comput. & Struct., vol. 82, pp. 2437-2445, 2004 +
  24. + +
  25. J. Ramirez, M. Laso +
    + Micro-macro simulations of three-dimensional plane + contraction flow + +
    + Modelling Simul. Mater. Sci. Eng., vol. 12, pp. 1293-1306, 2004 +
  26. + +
  27. R. B. + Schulz, W. Bangerth, J. Peter, W. Semmler +
    + Independent modeling of + fluorescence excitation and emission with the finite element method + +
    + Proceedings + of the OSA BIOMED topical meeting, Miami, Florida, 14-18 April 2004 +
  28. + +
  29. E. Zander, J. R. Weimar, H. G. Mathies +
    + Simulation of High-Frequency Atmospheric Gas Discharges + +
    + PAMM, vol. 4, pp. 428-429, 2004 +
  30. + +
+ + + + +

Publications in 2003

+ +
    +
  1. + S. Achatz +
    + Adaptive finite Dünngitter-Elemente höherer Ordnung + für elliptische partielle Differentialgleichungen mit variablen + Koeffizienten + +
    + Ph.D. thesis, TU Munich, 2003 +
  2. + +
  3. + W. Bangerth +
    + Starting threads in a C++ compatible fashion + +
    + C/C++ Users Journal, October 2003, pp. 21-24 +
  4. + +
  5. W. Bangerth, R. Rannacher +
    + Adaptive Finite Element Methods for Solving Differential Equations + +
    + Book, Birkhäuser, 2003 +
  6. + +
  7. M. Calhoun-Lopez +
    + Numerical solutions of hyperbolic conservation laws: + Incorporating multi-resolution viscosity methods into the + finite element framework + +
    + Ph.D. thesis, Iowa State University, 2003 +
  8. + +
  9. B. Carnes +
    + Adaptive finite elements for nonlinear transport equations + +
    + Ph.D. thesis, ICES, The University of Texas at Austin, 2003 +
  10. + +
  11. + B. Cockburn, + G. Kanschat, + D. Schötzau +
    + LDG methods for Stokes flow problems +
    + in Brezzi, Buffa, Corsaro, Murli: Numerical Mathematics and Advanced Applications: + ENUMATH 2001, Springer Italia, 2003 +
    + (Abstract + ) +
  12. + +
  13. + B. Cockburn, + G. Kanschat, + D. Schötzau +
    + The Local Discontinuous Galerkin Method for the Oseen Equations +
    + Math. Comput., vol. 73, pp. 569-593, 2003 +
    + (Abstract) +
  14. + +
  15. + J. Gopalakrishnan, + G. Kanschat +
    + Application of unified DG analysis to preconditioning DG methods + +
    + in Bathe: Computational Fluid and Solid Mechanics, pp. 1943-1945, 2003 +
  16. + +
  17. + J. Gopalakrishnan, + G. Kanschat +
    + A Multilevel Discontinuous Galerkin Method + +
    + Numer. Math., vol. 95, pp. 527-550, 2003 +
    + (Abstract, + BibTeX + entry, + Postscript) +
  18. + +
  19. + Jay Gopalakrishnan, G. Kanschat +
    + Multi-level Preconditioners for the interior penalty method +
    + in Brezzi, Buffa, Corsaro, Murli: Numerical Mathematics and Advanced Applications: + ENUMATH 2001, Springer Italia, 2003 +
    + (Abstract) +
  20. + +
  21. R. Hartmann, P. Houston +
    + Goal-Oriented A Posteriori Error Estimation + for Multiple Target Functionals + +
    + in T. Y. Hou and E. Tadmor, editors, Hyperbolic Problems: + Theory, Numerics, Applications, pp. 579-588, Springer, 2003 +
    + (Abstract, + BibTeX + entry) +
  22. + +
  23. R. Hartmann, P. Houston +
    + Goal-Oriented A Posteriori Error Estimation for Compressible Fluid Flows + +
    + In F. Brezzi, A. Buffa, S. Corsaro and A. Murli, editors, + Numerical Mathematics and Advanced Applications, pp. 775-784, Springer, 2003 +
    + (Abstract, + BibTeX + entry) +
  24. + +
  25. + G. Kanschat +
    + Discontinuous Galerkin Finite Element Methods for Advection-Diffusion Problems +
    + Habilitationsschrift, Universität Heidelberg, 2003 +
  26. + +
  27. + G. Kanschat +
    + Preconditioning discontinuous Galerkin saddle point systems +
    + in Bathe: Computational Fluid and Solid Mechanics, pp. 2016-2018, 2003 +
  28. + +
  29. + G. Kanschat +
    + Preconditioning methods for local discontinuous {G}alerkin Discretizations +
    + SIAM J. Sci. Comput., vol. 25, pp. 815-831, 2003 +
  30. + + +
  31. A. + Schneebeli, D. + Schötzau +
    + Mixed finite elements for incompressible magneto-hydrodynamics + +
    + Comptes Rendus Mathematique, vol. 337, pp. 71-74, 2003 +
  32. + +
  33. M. Stadler, G. A. Holzapfel, J. Korelc +
    + Cn continuous modelling of smooth contact surfaces + using NURBS and application to 2D problems + +
    + International Journal for Numerical Methods in Engineering, + vol. 57, pp. 2177-2203, 2003 +
  34. + +
+ + + +

Publications in 2002

+ +
    + +
  1. + W. Bangerth +
    + Adaptive Finite Element Methods for the + Identification of Distributed Parameters in + Partial Differential Equations + +
    + Ph.D. thesis, University of Heidelberg, 2002 +
    + (Abstract, + BibTeX + entry) +
  2. + +
  3. S. Benkler +
    + Numerical solution of the nonlinear Hartree equation. + +
    + Diploma thesis, ETH Zurich, Switzerland, 2002. +
  4. + +
  5. + B. Cockburn, + G. Kanschat, D. + Schötzau +
    + The local discontinuous Galerkin method in + incompressible fluid flow + +
    + in Mang, Rammerstorfer, Eberhardsteiner: Proceedings of the + Fifth World Congress on Computational Mechanics (WCCM V), + Vienna University of Technology, 2002 +
    + (Abstract, + BibTeX + entry, + Postscript) +
  6. + +
  7. + B. Cockburn, + G. Kanschat, D. + Schötzau, C. Schwab +
    + Local discontinuous Galerkin methods for the Stokes + system + +
    + SIAM J. Numer. Anal., vol. 40, pp. 319-343, 2002 +
    + (Abstract, + BibTeX + entry, + Postscript) +
  8. + +
  9. + R. Hartmann +
    + Adaptive Finite Element Methods for the Compressible + Euler Equations + +
    + Ph.D. thesis, University of Heidelberg, 2002 +
    + (Abstract, + BibTeX entry) +
  10. + +
  11. + R. Hartmann, P. Houston +
    + Adaptive Discontinuous Galerkin Finite Element + Methods for the Compressible Euler Equations + +
    + J. Comput. Phys., vol. 183, pp. 508-532, 2002. +
    + (Abstract, + BibTeX + entry) +
  12. + +
  13. + R. Hartmann, P. Houston +
    + Adaptive Discontinuous Galerkin Finite Element + Methods for Nonlinear Hyperbolic Conservation Laws + +
    + SIAM J. Sci. Comput., vol. 24, pp. 979-1004, 2002. +
    + (Abstract, + BibTeX + entry) +
  14. + +
  15. + G. Kanschat, Rolf Rannacher +
    + Local error analysis of the interior penalty + discontinuous Galerkin method for second order elliptic problems + +
    + J. Numer. Math., vol. 10, pp. 249-274, 2002 +
    + (Abstract, + BibTeX + entry, + Postscript) +
  16. + +
  17. F. Mohamed, M. Troyer, G. Blatter +
    + Interaction of vortices in superconductors with + kappa close to 1/sqrt(2), + +
    + Phys. Rev. B, vol. 65, article 224504, 2002. +
  18. + + +
  19. T. Shardlow +
    + A coupled Cahn-Hilliard particle system + +
    + Electronic Journal of Differential Equations, + vol. 2002, No. 73, pp. 1-21, 2002 +
  20. + + +
  21. M. Stadler, G. A. Holzapfel +
    + A novel approach for smooth contact surfaces using NURBS: + application to the FE simulation of stenting + +
    + Proceedings of the 13th Conference of the European Society of + Biomechanics, 1-4 September 2002, Wroclaw, Poland. +
  22. + +
+ + + + +

Publications in 2001

+ +
    +
  1. A. Barinka, T. Barsch, P. Charton, A. Cohen, S. Dahlke, + W. Dahmen, K. Urban +
    + Adaptive wavelet schemes for elliptic + problems—implementation and numerical experiments + +
    + SIAM J. Sci. Comput., + vol. 23, pp. 910-939, 2001 +
  2. + +
  3. + B. Cockburn, G. Kanschat, Ilaria Perugia, D. + Schötzau +
    + Superconvergence of the Local Discontinuous Galerkin + Method for Elliptic Problems on Cartesian Grids + +
    + SIAM J. Numer. Anal. 39 (1), pp. 264-285, 2001 +
    + (Abstract, + BibTeX + entry, + Postscript) +
  4. + +
  5. + T. Richter +
    + Funktionalorientierte Gitteroptimierung bei der Finite-Elemente + Approximation elliptischer Differentialgleichungen + +
    + Diploma thesis, University of Heidelberg, 2001 (in German)
    + (Abstract) +
  6. +
+ + + +

Publications in 2000

+ +
    + +
  1. + W. Bangerth +
    + Mesh Adaptivity and Error Control for a Finite Element + Approximation of the Elastic Wave + Equation + +
    + Proceedings of the Waves2000 conference, + held in Santiago de Compostela, Spain, July 10-14, 2000 +
    + (Abstract, + BibTeX + entry) +
  2. + +
  3. + W. Bangerth +
    + Multi-threading support in deal.II + +
    + Preprint 2000-11 (SFB 359), IWR Heidelberg, October 1999. +
    + This paper is also available + online. +
    + (Abstract, + BiBTeX entry) +
  4. + +
  5. + W. Bangerth +
    + Using Modern Features of C++ for Adaptive Finite + Element Methods: + Dimension-Independent Programming in deal.II + +
    + Proceedings of the 16th IMACS World + Congress, Lausanne, Switzerland, 2000 +
    + This paper is also available + online. +
    + (Abstract, + BibTeX entry) +
  6. + +
  7. R. Hartmann +
    + Adaptive FE-Methods for Conservation Equations + +
    + In Heinrich Freistühler and Gerald Warnecke, eds. + Hyperbolic problems: theory, numerics, applications: + eighth international conference in Magdeburg, 2000. +
    + International series of numerical mathematics 141: 495-503. + Birkhäuser, Basel 2001. +
    + (Abstract, + BibTeX + entry) +
  8. + +
  9. F. Mohamed +
    + Interaction of vortices in superconductors with + kappa close to 1/sqrt(2), + +
    + Diploma thesis, ETH Zurich, 2000. +
  10. + +
+ + + + +

Publications in 1999

+ +
    +
  1. + W. Bangerth and + G. Kanschat +
    + Concepts for object-oriented finite element + software - the deal.II library + +
    + Preprint 99-43 (SFB 359), IWR Heidelberg, October 1999. +
    + (Abstract, + BibTeX + entry) +
  2. + +
  3. + W. Bangerth, R. Rannacher +
    + Adaptive finite element approximation of the acoustic wave + equation: Error estimation and mesh adaptation + +
    + East-West Journal of Numerical Mathematics, vol. 7, no. 4 (1999), + pp. 263-282 +
    + (Abstract, + BibTeX + entry) +
  4. +
  5. + W. Bangerth, R. Rannacher +
    + Adaptive finite element techniques for the acoustic + wave equation + +
    + Journal of Computational Acoustics, vol. 9, no. 2 + (2001), pp. 575-591 +
    + (Abstract, + BibTeX + entry) +
  6. + +
  7. + S. Nauber +
    + Adaptive Finite Elemente Verfahren für + selbstadjungierte Eigenwertprobleme + +
    + Diploma thesis, University of Heidelberg, 1999 (in German) +
  8. + +
+ + + + + + + + +

Publications in 1998

+ +
    +
  1. + W. Bangerth +
    + Adaptive Finite-Elemente-Methoden zur Lösung der + Wellengleichung mit Anwendung in der Physik der Sonne + +
    + Diploma thesis, University of Heidelberg, 1998 (in German) +
    + (Abstract, + BibTeX entry) +
  2. +
+ +
+ +
+ The deal.II mailing list
+ + + + diff --git a/deal.II/doc/publications/toc.html b/deal.II/doc/publications/toc.html deleted file mode 100644 index 0d3fda5736..0000000000 --- a/deal.II/doc/publications/toc.html +++ /dev/null @@ -1,3610 +0,0 @@ - - - - - The deal.II Publication List - - - - - -

Publications on and with deal.II

- -

- Our institutes are evaluated at regular intervals. Consequently, - we are interested in documenting the use of the programs and - libraries we create. To this end, this page collects - publications written on or with the help of - deal.II. If you have written - something, please let us know about it: the more comprehensive this - list is, the simpler it is for us to justify to our departments and - sponsors the effort we put into the library — something that helps all - of us in the end. -

- -

- Some other resources on the use of deal.II or its - development can also be found on - a page - where we collect a few presentations. -

- -

- - - - - - - - -
Table of contents
-
    -
  1. Referencing deal.II -
  2. Publications on details - of deal.II -
  3. Publications per year:
    - 2010 - 2011 -
    - 2000 - 2001 - 2002 - 2003 - 2004 - 2005 - 2006 - 2007 - 2008 - 2009 -
    - 1998 - 1999 -
-
-

- - - -

Referencing deal.II

- -

- For your convenience, we provide a BibTeX file with entries - for the publications in this section. -

- -

- If you write a paper using results obtained with the help of - deal.II, please cite one or both of the following - references: -

- -
    -
  1. W. Bangerth, - R. Hartmann and - G. Kanschat -
    - - deal.II — a general-purpose object-oriented finite element library - -
    - ACM Transactions on Mathematical Software, vol. 33, no. 4, article 24 -
    - DOI 10.1145/1268776.1268779 - (Preprint) -
    -
    -@Article{BangerthHartmannKanschat2007,
    -  author = 	 {Wolfgang Bangerth and Ralf Hartmann and Guido Kanschat},
    -  title = 	 {{deal.II} -- a General Purpose Object Oriented Finite Element Library},
    -  journal = 	 {ACM Trans. Math. Softw.},
    -  year = 	 2007,
    -  volume = 	 33,
    -  number = 	 4,
    -  pages = 	 {24/1--24/27}
    -}
    -
  2. -
  3. W. Bangerth - and - G. Kanschat -
    - deal.II Differential Equations - Analysis Library, Technical Reference - -
    - To be found on the project webpage http://www.dealii.org -
    -
    -@Manual{DealIIReference,
    -  title = 	 {{\tt deal.{I}{I}} Differential Equations Analysis Library,
    -                  Technical Reference},
    -  author = 	 {W. Bangerth and G. Kanschat},
    -  note =         {\texttt{http://www.dealii.org}},
    -  url =          {http://www.dealii.org}
    -}
    -
  4. -
- - - - - - - - - - -

Publications on details of deal.II

- -

- The following publications explain in great detail the - implementation of algorithms and data structures of the hp, multigrid and - distributed mesh components of deal.II: -

    - -
  1. - B. Janssen, - G. Kanschat, -
    - Adaptive Multilevel Methods with Local Smoothing for H1- - and Hcurl-Conforming High Order Finite Element Methods -
    - SIAM J. Sci. Comput., vol. 33/4, pp. 2095-2114, 2011 -
    - DOI: 10.1137/090778523 -
  2. -
  3. - W. Bangerth, - C. Burstedde, T. Heister, M. Kronbichler -
    - Algorithms and Data Structures for Massively Parallel Generic - Finite Element Codes -
    - to appear in ACM Trans. Math. Softw. - IAMCS - preprint 2011-187. - -

  4. - W. Bangerth, O. Kayser-Herold, -
    - Data Structures and Requirements for hp Finite Element - Software - -
    - ACM Trans. Math. Softw., vol. 36, pp. 4/1-31, 2009 -

    - -
  5. - G. Kanschat -
    - Multi-level methods for discontinuous Galerkin FEM on locally refined meshes -
    - Comput. & Struct., vol. 82, pp. 2437-2445, 2004 -

    -
- -

For massively parallel - computations, deal.II builds on the - p4est - library. If you use this functionality, please also cite the - p4est paper listed at their website. -

-

- deal.II is a component of the SPEC CPU2006 benchmark - suite. There are hundreds of papers that use and describe this - testsuite as a reference for compiler and hardware - optimizations. The following special issue gives a detailed - comparison with respect to many different metrics of the - benchmarks in SPEC CPU2006, including deal.II: -

- - -

Publications in 2011

- - -
    -
  1. - M. Allmaras, W. Bangerth -
    - Reconstructions in ultrasound modulated optical tomography - -
    - J. Inverse and Ill-posed Problems, accepted, 2011. -

    - -
  2. - F. Alouges, A. DeSimone, L. Heltai -
    - Numerical strategies for stroke optimization of - axisymmetric microswimmers - -
    - Mathematical Models and Methods in Applied Sciences, vol. 3, 2011. -

    - -
  3. - M. Arroyo, A. DeSimone, L. Heltai -
    - The role of membrane viscosity in the dynamics of fluid - membranes - -
    - arXiv:1007.4934, submitted, 2010. -

    - -
  4. W. Bangerth, - C. Burstedde, T. Heister, M. Kronbichler -
    - Algorithms and Data Structures for Massively Parallel Generic - Finite Element Codes -
    - Accepted for publication in the ACM Trans. Math. Softw. This paper is - also available as - IAMCS - preprint 2011-187 - -
  5. K. Benzarti, F. Freddi, M. Frémond -
    - A damage model to predict the durability of bonded - assemblies. Part I: Debonding behavior of FRP strengthened - concrete structures -
    - Construction and Building Materials, 25(2),547-555, 2011. -

    - -
  6. L. Blank, L. Sarbu, M. Stoll -
    - Preconditioning for Allen-Cahn variational - inequalities with non-local constraints -
    - submitted. Preprint 11/2010, Mathematik, Uni Regensburg, 2010. -

    - -
  7. A. Buehler, A. Rosenthal, T. Jetzfellner, A. Dima, - D. Razansky, V. Ntziachristos -
    - Model-based optoacoustic inversions with incomplete projection - data -
    - Med. Phys., vol. 38, pp. 1694-1704, 2011. -

    - -
  8. - Y. Efendiev, J. Galvis, R. Lazarov, J. Willems -
    - Robust Domain Decomposition Preconditioners for Abstract - Symmetric Positive Definite Bilinear Forms - -
    - arXiv:1105.1131v1 [math.NA] -

    - -
  9. - E. Emmrich, D. Šiška -
    - Full discretization of second-order nonlinear evolution - equatiosn: Strong convergence and applications - -
    - Preprint, University of Bielefeld, 2011. -

    - -
  10. - M. Freyer -
    - Automatische Segmentierung anatomischer Strukturen in - CT-Bildern eines hybriden FMT/XCT-Systems zur Verbesserung der - optischen Bildgebung - -
    - Ph.D. thesis, Ludwig-Maximilians-University Munich, Germany, 2011. -

    - -
  11. - J. Frohne -
    - FEM-Simulation der Umformtechnik metallischer - Oberflächen im Mikrokosmos - -
    - Ph.D. thesis, University of Siegen, Germany, 2011. -

    - -
  12. - T. George, A. Gupta, V. Sarin -
    - An empirical analysis of the performance of iterative - solvers for SPD systems - -
    - Submitted to ACM Trans. Math. Softw., 2011. -

    - -
  13. - A. Ginzburg -
    - Introduction to Geophysics (in Hebrew) - -
    - The Open University of Israel, 2011. -

    - -
  14. - J.-L. Guermond, A. Salgado -
    - Error analysis of a fractional time-stepping technique for - incompressible - flows with variable density. - -
    - SIAM J. of Numerical Analysis, vol. 49, pp. 917-944, 2011. -

    - -
  15. - R. Hartmann, J. Held, T. Leicht -
    - Adjoint-based error estimation and adaptive mesh refinement - for the RANS and k-ω turbulence model equations - -
    - J. Comput. Phys., accepted, 2010. -

    - -
  16. - R. Hartmann, J. Held, T. Leicht, F. Prill -
    - Error estimation and adaptive mesh refinement for aerodynamic flows - -
    - In N. Kroll, H. Bieler, H. Deconinck, V. Couallier, H. van der Ven and K. Sorensen, editors, - ADIGMA - A European Initiative on the Development of Adaptive - Higher-Order Variational Methods for Aerospace Applications, - Springer, to appear, 2010. -

    - -
  17. - T. Heister -
    - A Massively Parallel Finite Element Framework with - Application to Incompressible Flows -
    - Ph.D. thesis, University of Göttingen, Germany, 2011 -

    - -
  18. - B. Janssen, G. Kanschat -
    - Adaptive multilevel methods with local smoothing -
    - submitted, 2010. -

    - -
  19. - G. Jegert, A. Kersch, W. Weinreich, P. Lugli -
    - Monte Carlo Simulation of Leakage Currents in - TiN/ZrO2/TiN Capacitors -
    - IEEE Transactions on Electron Devices, vol. 58, pp. 327-334, 2011. -

    - -
  20. - M. Hinze, M. Kunkel, A. Steinbrecher, T. Stykel -
    - Model order reduction of coupled circuit-device systems -
    - Hamburger Beiträge zur Angewandten Mathematik, Nr. 2011-08. -

    - -
  21. - B. Janssen, - T. Wick -
    - Block Preconditioning with Schur Complements - for Monolithic Fluid-Structure Interactions -
    - Eccomas CFD 2010 proceedings, submitted, 2010. -

    - -
  22. - O. P. Iliev, R. D. Lazarov, J. Willems -
    - Variational multiscale finite element method for flows in - highly porous media -
    - SIAM Multiscale Modeling and Simulation, submitted, 2010 -

    - -
  23. - T. Leicht, R. Hartmann -
    - Error estimation and hp-adaptive mesh refinement for - discontinuous Galerkin methods - -
    - In Z. J. Wang, editor, Adaptive High-Order Methods in - Computational Fluid Dynamics - with applications in aerospace - engineering, World Science Books, to appear, 2010. -

    - -
  24. - T. Leicht, R. Hartmann -
    - Goal-oriented error estimation and hp-adaptive mesh - refinement for aerodynamic flows. - -
    - 49thAIAA Aerospace Sciences Meeting, submitted, 2010. -

    - -
  25. - C. E. Michoski, J. A. Evans, P. G. Schmitz -
    - Modeling Chemical Reactors I: Quiescent Reactors - -
    - Preprint, arXiv, 2010 -

    - -
  26. - T. Richter, T. Wick -
    - Fluid-Structure Interactions in ALE and - Fully Eulerian Coordinates - -
    - PAMM, submitted, 2010. -

    - -
  27. - A. Salgado -
    - A Diffuse Interface Fractional Time-Stepping Technique - for Incompressible Two-Phase Flows with Moving Contact Lines. - -
    - Submitted to Comp. Meths. Appl. Mech. Engrg., 2011. -

    - -
  28. - T. Wick -
    - Fluid-Structure Interaction based on Monolithic Variational - Formulations with Different Types of Pseudo-Structure Extension - -
    - submitted, 2010 -

    - -
  29. - T. Wick -
    - Solving Monolithic Fluid-Structure Interaction Problems in - Arbitrary Lagrangian Eulerian Coordinates with the deal.II Library - -
    - IWR Report, University of Heidelberg, Germany, 2011. -

    - -
  30. - T. D. Young -
    - A qualitative semi-classical treatment of an isolated - semi-polar quantum dot - -
    - J. Phys.: Conf. Ser., 28(10), 2011. -

    - -
  31. - L. Zhou, B. Yazici -
    - Discretization Error Analysis and Adaptive Meshing - Algorithms for Fluorescence Diffuse Optical Tomography in the - Presence of Measurement Noise -
    - IEEE Trans. Image Processing, vol. 20, pp. 1094-1111, 2011 -

    - -
  32. - L. Zhu, D. Schötzau -
    - A robust a posteriori error estimate for hp-adaptive DG - methods for convection-diffusion equations - -
    - IMA J. Numer. Math., in press, 2010 -

    -
- - -

Publications in 2010

- - -
    -
  1. - M. S. Alnæs, K.-A. Mardal -
    - On the efficiency of symbolic computations combined with code - generation for finite element methods - -
    - ACM Transactions on Mathematical Software, vol. 37, 8/1-26, 2010. -

    - -
  2. - W. Bangerth, M. Geiger, R. Rannacher -
    - Adaptive Galerkin finite element methods - for the wave equation - -
    - Computational Methods in Applied Mathematics, vol. 10, pp.3-48, 2010. -

    - -
  3. S. Bartle, A. McBride, B. D. Reddy -
    - Shell finite elements, with applications in biomechanics -
    - In: Kok, S. (Ed.): Proceedings of 7th South African Conference on - Computational and Applied Mechanics (University of Pretoria, Pretoria, - South Africa). 2010. -

    - -
  4. A. Cangiani, R. Natalini -
    - A spatial model of cellular molecular trafficking - including active transport along microtubules -
    - Journal of Theoretical Biology, vol. 267, pp. 614-625, 2010. -

    - -
  5. C.-C. Chueh, M. Secanell, W. Bangerth, N. Djilali -
    - Multi-level Adaptive Simulation of Transient Two-phase Flow in - Heterogeneous Porous Media -
    - Computers and Fluids, vol. 39, pp. 1585-1596, 2010. -

    - -
  6. C.-C. Chueh -
    - Integrated adaptive numerical methods for transient - two-phase flow in heterogeneous porous medi -
    - Ph.D. thesis, University of Victoria, 2010. -

    - -
  7. - T. Dally -
    - FE-Modelladaptivität für P-Laplace - -
    - Master's thesis, Universität Siegen, Germany, 2010 -

    - -
  8. - M. Freyer, A. Ale, R. Schulz, M. Zientkowska, - V. Ntziachristos, K.-H. Englmeier -
    - Fast automatic segmentation of anatomical structures - in x-ray computed tomography images to improve fluorescence - molecular tomography reconstruction -
    - Journal of Biomedical Optics, vol. 15, pp. 036006/1-8, 2010. -
    - -

  9. - F. Freddi, M. Frémond -
    - Collision and Fractures: a predictive theory - -
    - European Journal of Mechanics - A/Solids, vol. 29, pp. 998-1007, 2010. -

    - -
  10. - F. Freddi, G. Royer-Carfagni -
    - Regularized Variational Theories of Fracture: a - Unified Approach -
    - Journal of the Mechanics and Physics of Solids, vol. 58, - pp. 1154-1174, 2010. -
    - -

  11. - P. Ghysels, G. Samaey, P. Van Liedekerke, E. Tijskens, - H. Ramon, D. Roose -
    - Multiscale modeling of viscoelastic plant tissue - -
    - Int. J. Multisc. Comput. Engrg., vol. 8, pp. 379-396, 2010 -
    - -

  12. - P. Ghysels, G. Samaey, P. Van Liedekerke, E. Tijskens, - H. Ramon, D. Roose -
    - Coarse implicit time integration of a cellular scale particle - model for plant tissue deformation - -
    - Int. J. Multisc. Comput. Engrg., vol. 8, pp. 411-422, 2010 -
    - -

  13. - V. Girault, F. Murat, A. Salgado -
    - Finite element discretization of Darcy's equations with - pressure dependent porosity. - -
    - M2AN, vol. 44, pp. 1155-1191, 2010 -

    - -
  14. - M. Guven, L. Reilly-Raska, L. Zhou, B. Yazici -
    - Discretization Error Analysis and Adaptive Meshing - Algorithms for Fluorescence Diffuse Optical Tomography: Part - I -
    - IEEE Trans. Medical Imaging, vol. 29, pp. 217-229, 2010 -

    - -
  15. - M. Guven, L. Zhou, L. Reilly-Raska, B. Yazici -
    - Discretization Error Analysis and Adaptive Meshing - Algorithms for Fluorescence Diffuse Optical Tomography: Part - II -
    - IEEE Trans. Medical Imaging, vol. 29, pp. 230-245, 2010 -

    - -
  16. - R. Hartmann, J. Held, T. Leicht, F. Prill -
    - Discontinuous Galerkin methods for computational aerodynamics - — 3D adaptive flow simulation with the DLR PADGE code - -
    - Aerospace Science and Technology, vol. 14, pp. 512-529, 2010. -

    - -
  17. - R. Hartmann, P. Houston -
    - Error estimation and adaptive mesh refinement for aerodynamic flows -
    - In H. Deconinck, editor, - VKI LS 2010-01: 36th CFD/ADIGMA course on hp-adaptive and - hp-multigrid methods, Oct. 26-30, 2009. -
    - Von Karman Institute for Fluid Dynamics, Rhode Saint Genese, - Belgium, 2010. -

    - -
  18. - R. Hartmann, T. Leicht -
    - Discontinuous Galerkin Verfahren in der Aerodynamik: - Höhere Ordnung, Fehlerschätzung und Gitteradaption - -
    - STAB Mitteilungen. 17. DGLR-Fach-Symposium der STAB, 9.-10. Nov. 2010, Berlin, 2010. -

    - -
  19. - T. Heister, G. Lube, G. Rapin -
    - On robust parallel preconditioning for incompressible - flow problems -
    - In Numerical Mathematics and Advanced Applications, ENUMATH 2009. - Springer, Berlin, 2010. -

    - -
  20. - T. Heister, M. Kronbichler, W. Bangerth -
    - Generic Finite Element programming for massively parallel - flow simulations -
    - Eccomas CFD 2010 proceedings, 2010. -

    - -
  21. - T. Heister, M. Kronbichler, W. Bangerth -
    - Massively Parallel Finite Element Programming -
    - Recent Advances in the Message Passing Interface, - Lecture Notes in Computer Science, vol. 6305/2010, pp. 122-131, - 2010. -

    - -
  22. - O. P. Iliev, R. D. Lazarov, J. Willems -
    - Discontinuous Galerkin Subgrid Finite Element Method for - Heterogeneous Brinkman Equations -
    - Large-Scale Scientific Computing, Lectures Notes in Computer Science, - vol. 5910, pp. 14-25, 2010 -

    - -
  23. - O. P. Iliev, R. D. Lazarov, J. Willems -
    - Fast numerical upscaling of heat equation for fibrous - materials -
    - J. Computing and Visualization in Science, vol. 13, pp. 275-285, 2010 -

    - -
  24. - G. Kanschat, B. Rivière -
    - A strongly conservative finite element method for the coupling - of Stokes and Darcy flow - -
    - J. Computational Physics, vol. 229, pp. 5933-5943, 2010 -

    - -
  25. - F. Keller, M. Feist, H. Nirschl, W. Dörfler -
    - Investigation of the nonlinear effects during the - sedimentation process of a charged colloidal particle by - direct numerical simulation - -
    - Journal of Colloid and Interface Science, vol. 344, pp. 228-236, 2010. -

    - -
  26. - S. Kim, J. E. Pasciak -
    - Analysis of a Cartesian PML approximation to acoustic - scattering problems in R2 -
    - J. Math. Anal. Appl., vol. 370, pp. 168-186, 2010 -

    - -
  27. - R. King, V. Mehrmann, W. Nitsche -
    - Active Flow Control—A Mathematical Challenge -
    - Production Factor Mathematics, Part 1, pp. 73-80, 2010 -

    - -
  28. - R. King, V. Mehrmann, W. Nitsche -
    - Aktive Strömungsbeeinflussung — Eine - Mathematische Herausforderung -
    - Produktionsfaktor Mathematik, Part 2, pp. 99-109, 2010 -

    - -
  29. - T. Leicht, R. Hartmann -
    - Error estimation and anisotropic mesh refinement for - 3d laminar aerodynamic flow simulations - -
    - J. Comput. Phys., vol. 229, pp. 7344-7360, 2010. -

    - -
  30. - T. Leicht, R. Hartmann -
    - Error estimation and anisotropic mesh refinement for - aerodynamic flow simulations - -
    - In Numerical Mathematics and Advanced Applications, ENUMATH - 2009, pp. 579-587. Springer, Berlin, 2010. -

    - -
  31. - G. Lube, B. Tews -
    - Optimal control of singularly perturbed - advection-diffusion-reaction problems -
    - Math. Model. Meths. Appl. Sc., Vol. 20, No. 3, 375-395, 2010. - (DOI)
    - Preprint 2008-15, Institute for Numerical and Applied - Mathematics, University of Göttingen, Germany, 2008 -

    - -
  32. - C. P. T. Neuen -
    - A multiscale approach to the Poisson-Nernst-Planck equation - -
    - Diploma Thesis, University of Bonn, Germany, 2010 -

    - -
  33. - A. Nigro, C. De Bartolo, R. Hartmann, F. Bassi -
    - Discontinuous Galerkin solution of preconditioned Euler equations for very low Mach number flows - -
    - Int. J. Numer. Meth. Fluids, vol. 63, no. 4, pp. 449-467, 2010. -

    - -
  34. - F. Prill -
    - Diskontinuierliche Galerkin-Methoden und schnelle iterative - Löser zur Simulation kompressibler Strömungen - -
    - PhD thesis, TU Hamburg-Harburg, 2010. (in German) -
    - Also available as DLR-FB 2010-17, DLR, 2010. ISSN 1434-8454. -

    - -
  35. - K. Rupp -
    - Symbolic integration at compile time in finite element methods - -
    - Proceedings of the 2010 International Symposium on Symbolic - and Algebraic Computation, 347-354, 2010. -

    - -
  36. - T. Rees, M. Stoll, A. Wathen -
    - All-at-once preconditioning in PDE-constrained - optimization - -
    - Kybernetica, vol. 46, pp. 341-360, 2010. -

    - -
  37. - T. Richter, T. Wick -
    - Finite Elements for Fluid-Structure - Interaction in ALE and Fully Eulerian Coordinates - -
    - Comput. Meth. Appl. Mech. Engrg., vol. 199, pp. 2633-2642, 2010. -

    - -
  38. - L. Röhe, G. Lube -
    - Analysis of a variational multiscale method for large-eddy - simulation and its application to homogeneous isotropic turbulence - -
    - Comput. Meth. Appl. Mech. Engrg., vol. 199, pp. 2331-2342, 2010. -

    - -
  39. - A. Salgado -
    - Approximation Techniques for Incompressible Flows - with Heterogeneous Properties -
    - Ph.D. thesis, Texas A&M University, 2010. -

    - -
  40. - R. Schulz, A. Ale, A. Sarantopoulos, M. Freyer, E. Soehngen, - M. Zientkowska, V. Ntziachristos -
    - Hybrid System for Simultaneous Fluorescence and X-Ray - Computed Tomography -
    - IEEE Trans. Medical Imaging, vol. 29, pp. 465-473, 2010 -

    - -
  41. - M. Secanell, R. Songprakorp, N. Djilali, A. Suleman -
    - Optimization of a proton exchange membrane fuel cell - electrode assembly - -
    - Structural and Multidisciplinary Optimization, vol. 40, pp. 563-583, - 2010 -

    - -
  42. - M. Steigemann, M. Specovius-Neugebauer, M. Fulland, H. A. Richard -
    - Simulation of crack paths in functionally graded materials - -
    - Engineering Fracture Mechanics, vol. 77, pp. 2145-2157, 2010 -

    - -
  43. - M. Stoll, A. Wathen -
    - All-at-once preconditioning of time-dependent PDE-constrained - optimization problems - -
    - Preprint 1017, University of Oxford, 2010. -

    - -
  44. - B. Turcksin, J. C. Ragusa, W. Bangerth -
    - Goal-oriented h-adaptivity for the multigroup SPN - equations - -
    - Nuclear Science and Engineering, vol. 165, pp. 305-319, 2010. -

    - -
  45. - M. Vdroljak -
    - On Hashin-Shtrikman bounds for mixtures of two isotropic - materials - -
    - Nonlinear Analysis: Real world applications, vol. 11, pp. 4597-4606, 2010 -

    - -
  46. - C. Weiler -
    - Stromfunktionsformulierung der - Navier-Stokes-Gleichungen und Methoden der - Druckrekonstruktion - -
    - Diploma Thesis, University of Heidelberg, Germany, 2010 -

    - -
  47. - T. Wick -
    - Monolithic Fluid-Structure Interaction Modelling for - a Long Axis Heart Valve Simulation - -
    - Preprint, IWR Heidelberg, Germany, 2010 -

    - -
  48. - T. D. Young, R. Armiento -
    - Strategies for h-adaptive refinement for a - finite element treatment of harmonic oscillator - Schrödinger eigenproblem - -
    - Commun. Theor. Phys. (Beijing, China), vol. 53(6), - pp. 1017-1023, 2010. -

    - -
  49. - L. Zhu -
    - Robust a posteriori error estimation for discontinuous - Galerkin methods for convection-diffusion equations - -
    - Ph.D. thesis, University of British Columbia, 2010 -

    -
- - -

Publications in 2009

- - -
    -
  1. - W. Bangerth, A. Joshi -
    - Adaptive finite element methods for nonlinear inverse - problems - -
    - Proceedings of the 2009 ACM Symposium on Applied Computing, 2009. -

    - -
  2. - W. Bangerth, O. Kayser-Herold -
    - Data Structures and Requirements for hp Finite Element - Software - -
    - ACM Trans. Math. Softw., vol. 36, pp. 4/1-31, 2009. -

    - -
  3. S. Bartle -
    - Shell finite elements with applications in biomechanics -
    - M.Sc. thesis, University of Cape Town, South Africa, 2009. -

    - -
  4. - F. Bassi, C. De Bartolo, R. Hartmann, A. Nigro -
    - A discontinuous Galerkin method for inviscid low Mach number flows - -
    - J. Comput. Phys., vol. 228, no. 11, pp. 3996-4011, 2009. -

    - -
  5. B. Brendel, T. Nielsen -
    - Selection of optimal wavelengths for spectral reconstruction - in diffuse optical tomography -
    - J. Biomed. Optics, vol. 14, 034041/1-034041/10, 2009. -

    - -
  6. C. Clason, P. Hepperger -
    - A forward approach to numerical data assimilation -
    - SIAM J. Sc. Comput., vol. 31, pp. 3090-3115, 2009 -

    - -
  7. B. Cockburn, G. Kanschat, and D. Schötzau -
    - An equal-order DG method for the incompressible Navier-Stokes - equations -
    - J. Sci. Comput., vol. 40, pp. 188-210, 2009. - DOI: 10.1007/s10915-008-9261-1 -

    - -
  8. - A. DeSimone, L. Heltai, C. Manigrasso -
    - Tools for the Solution of PDEs Defined on - Curved Manifolds with the deal.II Library - -
    - Prep. SISSA 42/2009/M. -

    - -
  9. - F. Freddi, G. Royer-Carfagni -
    - From Non-Linear Elasticity to Linearized Theory: - Examples Defying Intuition - -
    - J. of Elasticity, vol. 96, pp. 1-26, 2009 -
    - -

  10. - P. Ghysels, G. Samaey, B. Tijskens, P. Van Liedekerke, - H. Ramon, D. Roose -
    - Multi-scale simulation of plant tissue deformation - using a model for individual cell mechanics - -
    - Phys. Biol., vol. 6, pp. 016009/1-14, 2009 -
    - -

  11. - S. Gladkov, M. Stiemer, B. Svendsen -
    - Phase-field-based modeling and simulation of solidification - and deformation behavior of technological alloys - -
    - PAMM, vol. 8, pp. 10547-10548, 2009 -
    - -

  12. - R. Hartmann, M. Lukacova-Medvidova, F. Prill -
    - Efficient preconditioning for the discontinuous - Galerkin finite element method by low-order elements -
    - Appl. Numer. Math., vol. 59, no. 8, pp. 1737-1753, 2009 -

    - -
  13. H. K. Hesse, - G. Kanschat -
    - Mesh Adaptive Multiple Shooting for Partial Differential - Equations. Part I: Linear Quadratic Optimal Control Problems -
    - Journal of Numerical Mathematics, vol. 17, pp. 195-217 2009 -

    - -
  14. - D. Hyde, R. Schulz, D. Brooks, E. Miller, V. Ntziachristos -
    - Performance dependence of hybrid x-ray computed - tomography/fluorescence molecular tomography on the optical - forward problem -
    - J. Optical Soc. Amer., vol. 26, pp. 919-923, 2009 -

    - -
  15. - T. Jetzfellner, D. Razansky, A. Rosenthal, R. Schulz, - K.-H. Englmeier, V. Ntziachristos -
    - Performance of iterative optoacoustic tomography with - experimental data -
    - Appl. Phys. Lett., vol. 95, pp. 013703/1-3, 2009 -

    - -
  16. - J. Jung -
    - Mehrgitterverfahren für FE-Modelle 4. Ordnung - -
    - Master's thesis, Universität Siegen, Germany, 2009 -

    - -
  17. - S. Kim -
    - Analysis of a PML method applied to computation of - resonances in open systems and acoustic scattering problems -
    - Ph.D. thesis, Texas A&M University, 2009 -

    - -
  18. - S. Kim, J. E. Pasciak -
    - The computation of resonances in open systems using a - perfectly matched layer -
    - Math. Comp., vol. 78, pp. 1375-1398, 2009 -

    - -
  19. - N. Klein -
    - Modelladaptive FE-Techniken bei Elastizitätsproblemen - mit großen Verformungen - -
    - Master's thesis, Universität Siegen, Germany, 2009 -

    - -
  20. - J. Lorentzon -
    - Fluid-structure interaction (FSI) case study of a cantilever - using OpenFOAM and DEAL.II with application to VIV - -
    - Master's thesis, Lunds Institute of Technology, Sweden, 2009 -

    - -
  21. - G. Matthies, G. Lube, L. Röhe -
    - Some remarks on streamline-diffusion methods for inf-sup - stable discretisations of the generalised Oseen problem - -
    - Comp. Meths. Appl. Math. 9 (2009) 4, 1-23. -

    - -
  22. A. M. McMahon -
    - Modelling the Flow Behaviour of Gas Bubbles in a - Bubble Column -
    - M.Sc. thesis, University of Cape Town, South Africa, 2009. -

    - -
  23. - S. T. Miller, F. Costanzo -
    - A numerical verification for an unconditionally - stable FEM for elastodynamics -
    - Comp. Mech., vol. 43, pp. 223-237, 2009 -

    - -
  24. - M. Olshanskii, G. Lube, T. Heister, J. Löwe -
    - Grad-div stabilization and subgrid pressure models for the - incompressible Navier–Stokes equations -
    - Comp. Meth. Appl. Mech. Eng. V. 198, pp. 3975-3988, 2009 -

    - -
  25. - J. S. Pitt, F. Costanzo -
    - An adaptive h-refinement algorithm for local damage - models -
    - Algorithms, vol. 2, pp. 1281-1300, 2009 -

    - -
  26. - L. Plagne, F. Hülsemann, D. Barthou, J. Jaeger -
    - Parallel expression template for large vectors - -
    - Proceedings of the 8th workshop on Parallel/High-Performance - Object-Oriented Scientific Computing, European Conference on - Object-Oriented Programming, 2009. -

    - -
  27. - F. Prill, M. Lukacova-Medvidova, - R. Hartmann -
    - Smoothed aggregation multigrid for the discontinuous - Galerkin method - -
    - SIAM J. Sci. Comput., vol. 31, no. 5, pp. 3503-3528, 2009. -

    - -
  28. - F. Prill, M. Lukacova-Medvidova, - R. Hartmann -
    - A multilevel discontinuous Galerkin method for the - compressible Navier-Stokes equations - -
    - In A. Handlovicova, P. Frolkovic, K. Mikula and D. Sevcovic, eds., - Proceedings of ALGORITMY 2009. 18th Conference on Scientific - Computing Vysoke Tatry - Podbanske, Slovakia, March 15 - 20, - 2009. -

    - -
  29. - A. Q. Raeini -
    - Fractured reservoir simulation using finite element method - with logarithmic shape functions (in Persian) - -
    - M. Sc. thesis, Sharif University of Technology, Iran, 2009. -

    - -
  30. - H. R. Ramay and M. Vendelin -
    - Diffusion restrictions surrounding mitochondria: a - mathematical model of heart muscle fibers - -
    - Biophys. J., vol. 97, pp. 443-452, 2009. -

    - -
  31. - R. Rannacher -
    - Adaptive Finite Element Discretization of Flow - Problems for Goal-Oriented Model Reduction -
    - In: Computational Fluid Dynamics 2008 (H. Choi, H. - G. Choi and J. Y. Yoo, eds.), pp. 31-45, Springer, 2009. -

    - -
  32. - D. Schötzau, L. Zhu -
    - A robust a-posteriori error estimator for discontinuous - Galerkin methods for convection-diffusion equations - -
    - Appl. Numer. Math., vol. 59, pp. 2236-2255, 2009 -

    - -
  33. - N. Schröder -
    - Simulation eines mikrofluidischen Kanals mit deal.II - -
    - Master's thesis, Universität Siegen, Germany, 2009 -

    - -
  34. - Y. Wang -
    - Adaptive mesh refinement solution techniques for the - multigrid SN transport equation using a - higher-order discontinuous finite element method - -
    - Ph.D. thesis, Texas A&M University, 2009 -

    - -
  35. - Y. Wang, W. Bangerth, J. Ragusa -
    - Three-dimensional h-adaptivity for the multigroup neutron - diffusion equations - -
    - Progress in Nuclear Energy, vol. 51, pp. 543-555, 2009 -

    - -
  36. - S. Wanka -
    - Grundkonzepte zur Modelladaptivität bei Hindernisproblemen - -
    - Master's thesis, Universität Siegen, Germany, 2009 -

    - -
  37. - J. White -
    - Stabilized finite element methods for coupled flow - and geomechanics -
    - PhD thesis, Stanford University, 2009. -

    - -
  38. - J. Willems -
    - Numerical Upscaling for Multiscale Flow Problems - Analysis - and Algorithms -
    - Südwestdeutscher Verlag für Hochschulschriften, 2009. -

    - -
  39. - J. Willems -
    - Numerical upscaling for multiscale flow problems - -
    - Ph.D. thesis, University of Kaiserslautern, Germany, 2009 -

    - -
  40. - T. D. Young, E. Romero, and J. E. Roman -
    - Finite element solution of the stationary - Schrödinger equation using standard computational tools - -
    - In Proceedings of the International Conference on - Computational and Mathematical Methods in Science and - Engineering 2009, Gijon Asturias, Spain, July - 2009. -

    - -
  41. - T. D. Young -
    - Exemplifying quantum systems in a finite element - basis - -
    - In George Maroulis and Theodore E. Simos, editors, - Computational Methods in Science and Engineering: Advances in - Computational Science, number 1108, New York, USA, Mar - 2009. Proceedings of the International Conference on Computational - Methods in Sciences and Engineering, American Institute of Physics - Conference Proceedings, 2009. -

    - -
  42. - R. Ziegler, B. Brendel, A. Schipper, R. Harbers, M. van Beek, - H. Rinneberg, T. Nielsen -
    - Investigation of detection limits for diffuse optical - tomography systems: I. Theory and experiment - -
    - Phys. Med. Biol., vol. 54, pp. 399-412, 2009 -

    - -
  43. - R. Ziegler, B. Brendel, - H. Rinneberg, T. Nielsen -
    - Investigation of detection limits for diffuse optical - tomography systems: II. Analysis of slab and cup geometry for - breast imaging - -
    - Phys. Med. Biol., vol. 54, pp. 413-431, 2009 -

    - -
  44. - R. Ziegler, T. Nielsen, T. Koehler, D. Grosnick, - O. Steinkellner, A. Hagen, R. Macdonald, H. Rinneberg -
    - Nonlinear reconstruction of absorption and - fluorescence contrast from measured diffuse transmittance and - reflectance of a compressed-breast-simulating phantom - -
    - Applied Optics, vol. 48, pp. 4651-4662, 2009 -

    -
- - - - -

Publications in 2008

- - -
    -
  1. - W. Bangerth -
    - A framework for the adaptive finite element solution of - large-scale inverse problems - -
    - SIAM J. Sci. Comput, vol. 30, pp. 2965-2989, 2008 -

    - -
  2. - W. Bangerth, A. Joshi -
    - Adaptive finite element methods for the solution of - inverse problems in optical tomography - -
    - Inverse Problems, vol. 24, article 034011 (23 pages), 2008 -

    - -
  3. - E. Bängtsson, B. Lund -
    - A comparison between two solution techniques to solve - the equations of glacially induced deformation of an elastic - Earth - -
    - Int. J. Numer. Meth. Engrg., vol. 75, pp. 479-502, 2008 -

    - -
  4. - M. Bartels, A. Joshi, J. C. Rasmussen, E. M. Sevick-Muraca, - W. Bangerth -
    - Post-image acquisition excitation light mitigation in NIR - fluorescent tomography - -
    - Proceedings of the IEEE International - Symposium on Biomedical Imaging, Arlington, VA, 2008 -

    - -
  5. - B. Brendel, R. Ziegler, T. Nielsen -
    - Algebraic reconstruction techniques for spectral - reconstruction in diffuse optical tomography - -
    - Applied Optics, vol. 47, pp. 6392-6403, 2008 -

    - -
  6. - D. Boffi, L. Gastaldi, L. Heltai, - C. S. Peskin -
    - On the hyper-elastic formulation of - the immersed boundary method - -
    - Computer Methods in Applied Mechanics and Engineering, - vol. 197, pp. 2210-2231, 2008 -

    - -
  7. - B. Carnes, G. F. Carey -
    - Local boundary value problems for the error in FE - approximation of non-linear diffusion systems - -
    - Int. J. for Numer. Methods Engrg., vol. 73, - pp. 665-684, 2008 -

    - -
  8. - N. Djilali, P. C. Sui -
    - Transport phenomena in fuel cells: from microscale to - macroscale - -
    - Int. J. of Comput. Fluid Dynam., vol. 22, - pp. 115-133, 2008 -

    - -
  9. - R. Fosdick, F. Freddi, G. Royer-Carfagni -
    - Bifurcation instability in - linear elasticity with the constraint of local injectivity - -
    - J. of Elasticity, vol. 90, pp. 99-126, 2008 -

    - -
  10. - M. Geiger -
    - Vergleich dreier Zeitschrittverahren zur numerischen - Lösung der akustischen Wellengleichung -
    - Diploma thesis, University of Heidelberg, Germany, 2008 -

    - -
  11. - P. Ghysels, G. Samaey, B. Tijskens, - H. Ramon, D. Roose -
    - Multi-scale simulation of plant tissue deformation - using a model for individual cell behavior - -
    - Report TW 522, Department of Computer Science, K.U. Leuven, Belgium, - 2008 -
    - -

  12. - C. Giavarini, M. L. Santarelli, R. Natalini, F. Freddi -
    - A non linear model of - sulphation of porous stones: numerical simulations and preliminary - laboratory assessments - -
    - J. of Cultural Heritage, vol. 9, pp. 14-22, 2008 -

    - -
  13. - M. Grote, A. - Schneebeli, D. Schötzau -
    - Interior penalty discontinuous Galerkin method for - Maxwell's equations: optimal L2-norm estimates - -
    - IMA J. Numer. Anal., vol. 28, pp. 440-468, 2008 -

    - -
  14. - R. Hartmann -
    - Multitarget error estimation and adaptivity in aerodynamic flow simulations - -
    - SIAM J. Sci. Comput., vol. 31, no. 1, pp. 708-731, 2008 -

    - -
  15. - R. Hartmann -
    - Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods -
    - In H. Deconinck, editor, - VKI LS 2008-08: 35th CFD/ADIGMA course on very high order discretization methods, Oct. 13-17, 2008. -
    - Von Karman Institute for Fluid Dynamics, Rhode Saint Genese, Belgium (2008). -

    - -
  16. - R. Hartmann, P. Houston -
    - An optimal order interior penalty discontinuous - Galerkin discretization of the compressible Navier-Stokes - equations - -
    - J. Comput. Phys., vol. 227, no. 22, pp. 9670-9685, 2008 -

    - -
  17. - T. Heister -
    - Vorkonditionierunsstrategien für das - stabilisierte Oseen-Problem -
    - Diploma thesis, University of Göttingen, Germany, 2008 -

    - -
  18. L. Heltai -
    - On the stability of the finite element immersed - boundary method -
    - Computers and Structures, vol. 86, pp. 598-617, 2008 -

    - -
  19. - A. Joshi, W. Bangerth, E. Sevick -
    - Non-Contact Fluorescence Optical Tomography with - Adaptive Finite Element Methods - -
    - In: "Mathematical Methods in Biomedical Imaging and Intensity-Modulated - Radiation Therapy (IMRT)", Y. Censor, M. Jiang and A.K. Louis (eds.), - pp. 185-200, - Birkhäuser, 2008 -

    - -
  20. - G. Kanschat -
    - Robust smoothers for high order discontinuous Galerkin - discretizations of advection-diffusion problems -
    - J. Comput. Appl. Math., vol. 218, pp. 53-60, 2008. -
    - (Preprint) -

    - -
  21. - G. Kanschat, D. Schötzau -
    - Energy norm a-posteriori error estimation for divergence-free - discontinuous Galerkin approximations of the Navier-Stokes - equations - -
    - Int. J. Numer. Methods Fluids, vol. 57, pp. 1093-1113, 2008. - DOI: 10.1002/fld.1795 -

    - -
  22. - D. K. Khalmanova, F. Costanzo -
    - A space-time discontinuous Galerkin finite element method for - fully coupled linear thermo-elasto-dynamic problems with strain and - heat flux discontinuities - -
    - Comput. Meth. Appl. Mech. Engrg., vol. 197, pp. 1323-1342, 2008 -

    - -
  23. - L. Khasina -
    - Mathematische Behandlung von Mischungen - elastoplastischer Substanzen - -
    - PhD thesis, University of Bonn, Germany, 2008 -

    - -
  24. - M. Kronbichler, G. Kreiss -
    - A hybrid level–set–Cahn–Hilliard model for - two-phase flow - -
    - Proceedings of the 1st European Conference on Microfluidics, accepted - for publication. Microfluidics 2008, Bologna, Italy, December - 10–12, 2008. -

    - -
  25. - T. Leicht, R. Hartmann -
    - Anisotropic mesh refinement for discontinuous Galerkin methods - in two-dimensional aerodynamic flow simulations - -
    - Int. J. Numer. Meth. Fluids, vol. 56, no. 11, pp. 2111-2138, 2008 -

    - -
  26. - J. Löwe -
    - Stabilisierung durch lokale Projektion für - inkompressible Strömungsprobleme -
    - Diploma thesis, University of Göttingen, Germany, 2008 -

    - -
  27. - M. Neytcheva and E. Bängtsson -
    - Preconditioning of nonsymmetric saddle point systems as - arising in modelling of viscoelastic problems -
    - ETNA, vol. 29, pp. 193-211, 2008 - 2008 -

    - -
  28. - J. S. Pitt, F. Costanzo -
    - Theory and simulation of a brittle damage model in - thermoelastodynamics -
    - Proceedings of the 8th World Congress on Computational - Mechanics (WCCM 8), Venice, Italy, 2008 -

    - -
  29. - K. Schmid -
    - Theory and numerics of a reconstruction algorithm for a - problem from acoustic microscopy -
    - Diploma thesis, Technical University of Munich, Germany, - 2008 -

    - -
  30. - M. Secanell, K. Karan, A. Suleman, N. Djilali -
    - Optimal design of ultralow-platinum PEMFC anode electrodes - -
    - Journal of The Electrochemical Society, vol. 155, pp. B125-B134, 2008 -

    - -
  31. - M. Secanell, R. Songprakorp, A. Suleman, N. Djilali -
    - Multi-objective optimization of a polymer electrolyte - fuel cell membrane electrode assembly - -
    - Energy & Environmental Science, vol. 1, pp. 378-388, 2008 -

    - -
  32. - J. A. White, R. I. Borja -
    - Stabilized low-order finite elements for coupled - solid-deformation/fluid-diffusion and their application to - fault zone transients - -
    - Comput. Meth. Appl. Mech. Engrg., vol. 197, pp. 4353-4366, 2008 -

    - -
  33. - T. Wick -
    - Untersuchung von Kopplungsmechanismen von - Fluid-Struktur-Interaktion - -
    - Master's thesis, Universität Siegen, Germany, 2008 -

    -
- - - -

Publications in 2007

- -
    -
  1. - N. Antonic, M. Vrdoljak -
    - Gradient methods for multiple state optimal design problems - -
    - Ann. Univ. Ferrara, vol. 53, pp. 177-187, 2007 -

    - -
  2. - P. F. Antonietti, - L. Heltai -
    - Numerical validation of a class of mixed - discontinuous Galerkin methods for Darcy flow - -
    - Computer Methods in Applied Mechanics and Engineering, - vol. 196, pp. 4505-4520, 2007 -

  3. - -
  4. - W. Bangerth, - R. Hartmann, - G. Kanschat -
    - deal.II — a general-purpose object-oriented finite - element library - -
    - ACM Transactions on Mathematical Software, vol. 33, no. 4, article - 24, 2007 -

    - -
  5. - W. Bangerth, A. Joshi, E. Sevick -
    - Inverse biomedical imaging using separately adapted meshes - for parameters and forward model variables - -
    - Proceedings of the IEEE International Symposium on Biomedical Imaging, - Arlington, VA, pp. 1368-1371, 2007 -

    - -
  6. - E. Bängtsson, M. Neytcheva -
    - Finite Element Block-Factorized Preconditioners - -
    - Technical Report 2007-008, Uppsala University, Sweden, 2007 -

    - -
  7. - D. Boffi, L. Gastaldi, L. Heltai -
    - On the CFL condition for the finite element immersed - boundary method -
    - Computers & Structures, vol. 85, pp. 775-783, 2007 - (DOI) -

    - -
  8. - D. Boffi, L. Gastaldi, L. Heltai -
    - Numerical stability of the finite element immersed boundary method -
    - Mathematical Models and Methods in Applied Sciences, vol. 17, - pp. 1479-1505, 2007 -

    - -
  9. - M. Calhoun-Lopez, M. D. Gunzburger -
    - The efficient implementation of a finite element, - multi-resolution viscosity method for hyperbolic conservation - laws - -
    - Journal of Computational Physics, vol. 225, pp. 1288-1313, 2007 -

    - -
  10. - B. Carnes, G. F. Carey -
    - Estimating spatial and parameter error in - parameterized nonlinear reaction-diffusion equations - -
    - Communications in Numerical Methods in Engineering, vol. 23, - pp. 835-854, 2007 -

    - - -
  11. - C. C. Douglas, M. J. Cole, P. Dostert, Y. Efendiev, R. E. Ewing, - G. Haase, J. Hatcher, M. Iskandarani, C. R. Johnson, R. A. Lodder -
    - Dynamically identifying and tracking contaminants in water - bodies - -
    - International Conference on Computational Science ICCS 2007, - vol. 4487 of Springer Lecture Notes in Computer Science, - pp. 1002-1009, 2007 -

    - -
  12. - F. Freddi, M. Frémond -
    - Collision and Fractures: a predictive theory - -
    - Proceedings of the EuroSim Conference, Lubiana, Slovenia, - 9-13 September, 2007 -

    - -
  13. - P.K. Galenko, S. Reutzel, D. M. Herlach, D. Danilov, B. Nestler -
    - Modelling of dendritic solidification in undercooled - dilute Ni-Zr melts - -
    - Acta Materialia, vol. 55, pp. 6834-6842, 2007 -

    - -
  14. - A. Garny, J. Cooper, P. J. Hunt -
    - Toward a VPH/Physiome ToolKit - -
    - Wiley Interdisciplinary Reviews: Systems Biology and Medicine, - vol. 2, pp. 134-147, 2010 -

    - -
  15. - T. Ha, C. Shin -
    - Magnetotelluric inversion via reverse time migration - algorithm of seimic data - -
    - J. Comput. Phys., vol. 225, pp. 237-262, 2007 -

    - -
  16. - R. Hartmann -
    - Adjoint consistency analysis of Discontinuous Galerkin discretizations - -
    - SIAM J. Numer. Anal., vol. 45, no. 6, pp. 2671-2696, 2007 -

    - -
  17. - R. Hartmann -
    - Error estimation and adjoint based refinement for an adjoint - consistent DG discretization of the compressible Euler equations - -
    - Int. J. Computing Science and Mathematics, vol. 1, pp. 207-220, 2007 -

    - -
  18. - R. Hartmann -
    - DG discretizations for compressible flows: Adjoint - consistency analysis, error estimation and adaptivity - -
    - In R. Rannacher, E. Süli, and R. Verführt, eds., - Adaptive Numerical Methods for PDEs, Mathematisches - Forschungsinstitut Oberwolfach Report 29/2007, pp. 26-30, 2007 -

    - -
  19. P. Hepperger -
    - Ein POD-basierter Ansatz zur numerischen Lösung eines - Datenassimilationsproblems am Beispiel einer linearen - Diffusions-Konvektions-Gleichung -
    - Diploma thesis, Technical University of Munich, Germany, - 2007

  20. - -
  21. - Christian D. Kamm -
    - A posteriori error estimation in numerical methods - for solving self-adjoint eigenvalue problems - -
    - Diploma thesis, TU Berlin, Germany, 2007 -

  22. - -
  23. - O. Kayser-Herold, H.G. Matthies -
    - A unified least-squares formulation for fluid-structure interaction - problems - -
    - Computers and Structures, vol. 85, pp. 998-1011, 2007 -

    - -
  24. - B. Janssen, -
    - Vergleich verschiedener Finite-Elemente-Approximationen - zur numerischen Lösung der Plattengleichung -
    - Diploma thesis, University of Heidelberg, Germany, 2007. -

    - -
  25. - A. Joshi, W. Bangerth, R. Sharma, J. Rasmussen, W. Wang, - E. Sevick -
    - Molecular tomographic imaging of lymph nodes with - NIR fluorescence - -
    - Proceedings of the IEEE International Symposium on Biomedical Imaging, - Arlington, VA, pp. 564-567, 2007 -

    - -
  26. - B. Nestler, D. Danilov, A. Bracchi, - Y.-L. Huang, T. Niermann, M. Seibt and S. Schneider -
    - A metallic glass composite: Phase-field simulations - and experimental analysis of microstructure evolution - -
    - Materials Science and Engineering: A, vol. 452-453, pp. 8-14, 2007 -

    - -
  27. - A. Nigro -
    - Discontinuous Galerkin Methods for inviscid low Mach - number flows -
    - Ph.D. thesis, University of Calabria, 2007 -

    - -
  28. - P. J. Phillips and M. F. Wheeler -
    - A coupling of mixed and continuous Galerkin finite - element methods for poroelasticity II: the discrete-in-time case - -
    - Computational Geosciences, vol. 11, pp. 145-158, 2007 -

    - -
  29. - H.-J. Reinhardt, D. N. Hào, J. Frohne and F.-T. Suttmeier -
    - Numerical solution of Inverse Heat Conduction - Problems in two spatial dimensions - -
    - J. Inverse and Ill-Posed Problems, vol. 5, pp. 19-36, 2007 -

    - -
  30. - L. Röhe -
    - Residuale Stabilisierung für Finite Elemente Verfahren - bei inkompressiblen Strömungen -
    - Diploma thesis, University of Göttingen, Germany, 2007 -

    - -
  31. - M. Schmidt -
    - Systematic discretization of input/output maps and - other contributions to the control of distributed parameter - systems - -
    - Ph.D. thesis, TU Berlin, Germany, 2007 -

    - -
  32. - M. Secanell, B. Carnes, A. Suleman, N. Djilali -
    - Numerical optimization of proton exchange membrane fuel cell - cathodes - -
    - Electrochimica Acta, vol. 52, pp. 2668-2682, 2007 -

    - -
  33. - M. Secanell, K. Karan, A. Suleman, N. Djilali -
    - Multi-variable optimization of PEMFC cathodes using - an agglomerate model - -
    - Electrochimica Acta, vol. 52, pp. 6318-6337, 2007 -

    - -
  34. - M. Steigemann, M. Fulland, M. Specovius-Neugebauer, H. A. Richard -
    - Simulation of crack paths in functionally graded materials - -
    - PAMM, vol. 7, pp. 4030029-4030030, 2007 -

    - -
  35. - M. Steigemann, M. Fulland -
    - On the computation of the pure Neumann problem in - 2-dimensional elasticity - -
    - International Journal of Fracture, vol. 146, pp. 265-277, 2007 -

    - -
  36. - R. Ziegler, T. Nielsen, T. Koehler, D. Grosenick, - O. Steinkellner, A. Hagen, R. Macdonald, H. Rinneberg -
    - Reconstruction of absorption and fluorescence - contrast for scanning time-domain fluorescence mammography - -
    - Optical Tomography and Spectroscopy of Tissue VII, Proc. SPIE - vol. 6434, 64340H/1-11, 2007 -

    -
- - - - -

Publications in 2006

- -
    - -
  1. - M. Allmaras -
    - Optimal Design of Periodic Microstructures by the - Inverse Homogenization Method - -
    - Diploma Thesis, Technical University Munich, Germany, 2006 -

    - -
  2. - N. Antonic, M. Vrdoljak -
    - Sequential laminates in multiple state optimal design problems - -
    - Mathematical Problems in Engineering, vol. 2006, pp. 1-14, 2006 -

    - -
  3. - P. F. Antonietti -
    - Domain decomposition, spectral correctness and - numerical testing of discontinuous Galerkin methods - -
    - Ph.D. thesis, University of Pavia, Italy, 2007 -

  4. - -
  5. - E. Bängtsson, B. Lund -
    - A comparison between two approaches to solve the equations of - isostasy - -
    - Institute for Parallel Processing (BIS 21++) Technical Report 2006-03, - Bulgarian Academy of Sciences, 2006 -

    - -
  6. - E. Bängtsson, B. Lund -
    - A comparison between two approaches to solve the equations of - isostasy - -
    - Technical Report 2006-051, Uppsala University, Sweden, 2006 -

    - -
  7. - E. Bängtsson, M. Neytcheva -
    - Numerical simulations of glacial rebound using - preconditioned iterative solution methods - -
    - Applications of Mathematics, vol. 50, pp. 183-201, 2006 -

    - -
  8. - E. Bängtsson, M. Neytcheva -
    - An agglomerate multilevel preconditioner for linear - isostasy saddle point problems - -
    - Proceedings of Large-Scale Scientific Computing: 5th - International Conference (I. Lirkov, S. Margenov, - J. Wasniewski, eds), pp. 113-120, 2006 -

    - -
  9. - B. Carnes, N. Djilali -
    - Analysis of coupled proton and water transport in a - PEM fuel cell using the binary friction membrane model - -
    - Electrochimica Acta, vol. 52, pp. 1038-1052, 2007 -

    - -
  10. - D. Danilov, B. Nestler -
    - Phase-field simulations of eutectic solidification - using an adaptive finite element method - -
    - International Journal of Modern Physics B, vol. 20, - pp. 853-867, 2006 -

    - -
  11. - J. Frohne -
    - Numerische Lösung des inversen - Wärmeleitproblems in zwei - Ortsdimensionen zur Identifizierung von Randbedingungen - -
    - Diploma thesis, Universität Siegen, Germany, 2009 -

    - -
  12. - M. Grote, A. - Schneebeli, D. Schötzau -
    - Discontinuous Galerkin Finite Element Method for the Wave Equation - -
    - SIAM J. Numer. Anal, vol. 44, pp. 2408-2431, 2006 -

    - -
  13. - T. Ha, C. Shin -
    - Two dimensional magnetotelluric inversion via reverse - time migration algorithm - -
    - Abstracts of the SEG Annual Meeting in New Orleans, - pp. 830-835, 2006 -

    - -
  14. - R. Hartmann -
    - Error estimation and adjoint-based adaptation in aerodynamics - -
    - In P. Wesseling, E. Onate, J. Periaux, eds., - Proceedings of the ECCOMAS CFD 2006, Sept. 5-8, Egmond aan Zee, - The Netherlands, 2006 -

    - - -
  15. - R. Hartmann -
    - Derivation of an adjoint consistent discontinuous Galerkin - discretization of the compressible Euler equations - -
    - In G. Lube and G. Rapin, eds., - Proceedings of the BAIL 2006 Conference, 2006 -

    - - -
  16. - R. Hartmann -
    - Adaptive discontinuous Galerkin methods with - shock-capturing for the compressible Navier-Stokes equations - -
    - Int. J. Numer. Meth. Fluids, vol. 51, pp. 1131-1156, 2006 -

    - -
  17. - R. Hartmann, P. Houston -
    - Symmetric Interior Penalty DG Methods for the - Compressible Navier-Stokes Equations I: Method Formulation - -
    - Int. J. Numer. Anal. Model., vol. 3, pp. 1-20, 2006. -

    - - -
  18. - R. Hartmann, P. Houston -
    - Symmetric Interior Penalty DG Methods for the - Compressible Navier-Stokes Equations II: Goal-Oriented A - Posteriori Error Estimation - -
    - Int. J. Numer. Anal. Model., vol. 3, pp. 141-162, 2006 -

    - -
  19. L. Heltai -
    - The Finite Element Immersed Boundary Method -
    - Ph.D. thesis, Università di Pavia, Dipartimento di Matematica "F. Casorati", - 2006

  20. - -
  21. - K. Hwang, T. Pan, A. Joshi, J. C. Rasmussen, W. Bangerth, - E. Sevick-Muraca -
    - Influence of excitation light rejection on forward model - mismatch in optical tomography - -
    - Phys. Med. Biol., vol. 51, pp. 5889-5902, 2006 -

    - -
  22. - A. Joshi, W. Bangerth, E. Sevick-Muraca -
    - Non-contact fluorescence optical tomography with scanning - patterned illumination - -
    - Optics Express, vol. 14, - pp. 6516-6534, 2006 -

    - -
  23. - A. Joshi, W. Bangerth, K. Hwang, J. C. Rasmussen, - E. Sevick-Muraca -
    - Fully adaptive FEM based fluorescence optical tomography from - time-dependent measurements with area illumination and detection - -
    - Med. Phys., vol. 33, - pp. 1299-1310, 2006 -

    - -
  24. - A. Joshi, W. Bangerth, E. Sevick-Muraca -
    - Non-contact fluorescence optical tomography with scanning - illumination - -
    - Proceedings of the IEEE International Symposium on Biomedical Imaging, - Arlington, VA, 2006, pp. 582-585, 2006 -

    - -
  25. - A. Joshi, W. Bangerth, K. Hwang, J. C. Rasmussen, - E. Sevick-Muraca -
    - Plane wave fluorescence tomography with adaptive finite - elements - -
    - Optics Letters, vol. 31, - pp. 193-195, 2006 -

    - -
  26. - O. Kayser-Herold -
    - Least-Squares Methods for the Solution of Fluid-Structure - Interaction Problems - -
    - Ph.D. thesis, TU-Braunschweig, Germany, 2006 -
    - Available online through this link -

    - -
  27. - T. Leicht -
    - Anisotropic Mesh Refinement for Discontinuous Galerkin - Methods in Aerodynamic Flow Simulations - -
    - Diploma thesis, TU Dresden, 2006 -
    - Available online through this link -

    - -
  28. - D. Oeltz -
    - Ein Raum-Zeit Dünngitterverfahren zur Diskretisierung - parabolischer Differentialgleichungen - -
    - Ph.D. thesis, University of Bonn, Germany, 2006 -

    - -
  29. - M. Schmidt -
    - Low-dimensional I/O modeling of distributed parameter - systems - -
    - Proc. Appl. Math. Mech., vol. 6, pp. 15-18, 2006 -

    - -
- - - -

Publications in 2005

- -
    - -
  1. - M. Anderson, W. Bangerth, G. Carey -
    - Analysis of parameter sensitivity and experimental - design for a class of nonlinear partial differential - equations - -
    - International Journal for Numerical Methods in Fluids, vol. 48, - pp. 583-605, 2005 -

    - -
  2. - W. Bangerth, A. Joshi, E. Sevick-Muraca -
    - Adaptive finite element methods for increased - resolution in fluorescence optical tomography - -
    - Progress in Biomedical Optics and Imaging, vol. 6, - pp. 318-329, 2005 -

    - -
  3. - D. Boffi, L. Gastaldi, L. Heltai -
    - The finite element immersed boundary method: model, stability, and numerical - results -
    - In Schrefler Papadrakakis, Onate, eds., Computational Methods for - Coupled Problems in Science and Engineering, 2005

  4. - -
  5. - D. Boffi, L. Gastaldi, L. Heltai -
    - Stability results and algorithmic strategies for the finite - element approach to the immersed boundary method - -
    - Proceeding of the Sixth European Conference on Numerical Mathematics - and Advanced Applications (ENUMATH 2005), pages 557-566, 2005 -

    - -
  6. - M. Calhoun-Lopez, M. D. Gunzburger -
    - A Finite Element, Multiresolution Viscosity Method - for Hyperbolic Conservation Laws - -
    - SIAM J. Numer. Anal., vol. 43, pp. 1988-2011, 2005 -

    - -
  7. - B. Carnes, N. Djilali -
    - Systematic parameter estimation for PEM fuel cell models - -
    - Journal of Power Sources, vol. 144, pp. 83-93, 2005 -

    - -
  8. - B. Cockburn, - G. Kanschat, - D. Schötzau -
    - A locally conservative LDG method for the incompressible Navier- Stokes equations -
    - Math. Comput., vol. 74, pp. 1067-1095, 2005 -

    - -
  9. - B. Cockburn, - G. Kanschat, - D. Schötzau -
    - The Local Discontinuous Galerkin Method for Linear - Incomressible Fluid Flow: a Review -
    - Comput. & Fluids, vol. 34, pp. 491-506, 2005 -

    - -
  10. - R. Hartmann -
    - Discontinuous Galerkin methods for compressible flows: - higher order accuracy, error estimation and adaptivity - -
    - In H. Deconinck and M. Ricchiuto, editors, - VKI LS 2006-01: CFD - Higher Order Discretization Methods, - November 14-18, 2005, Rhode Saint Genese, Belgium. -
    - von Karman Institute for Fluid Dynamics (2005) -

    - -
  11. - A. Joshi -
    - Adaptive finite element methods for fluorescence enhanced - optical tomography - -
    - Ph.D. thesis, Texas A&M University, 2005 -

    - -
  12. - A. Joshi, W. Bangerth, A. B. Thompson, E. Sevick-Muraca -
    - Experimental fluorescence optical tomography using - adaptive finite elements and planar illumination with - modulated excitation light - -
    - Progress in Biomedical Optics and Imaging, vol. 6, - pp. 351-358, 2005 -

    - -
  13. - G. Kanschat -
    - Block Preconditioners for LDG Discretizations of - Linear Incompressible Flow Problems -
    - J. Sci. Comput., vol. 22, pp. 381-394, 2005 -

    - -
  14. - O. Kayser-Herold, H. G. Matthies -
    - Least squares finite element methods for fluid-structure - interaction problems - -
    - Computers & Structures, vol. 83, pp. 191-207, 2005 -

    - -
  15. - R. Li -
    - On multi-mesh h-adaptive methods -
    - J. Sci. Comput., vol. 24, pp. 321-341, 2005 -
    - (This paper uses AFEPack which in turn uses deal.II's linear - algebra library.) -

    - -
  16. - M. Mu -
    - PDE.MART: A network-based problem-solving environment - for PDEs - -
    - ACM Trans. Math. Software, vol. 31, pp. 508-531, 2005 -

    - -
  17. - B. Nestler, D. Danilov, P. Galenko -
    - Crystal growth of pure substances: Phase-field simulations in - comparison with analytical and experimental results - -
    - Journal of Computational Physics, vol. 207, pp. 221-239, 2005 -

    - -
  18. - T. Nielsen, T. Koehler, M. van der Mark, G. t'Hooft -
    - Fully 3D reconstruction of attenuation for diffuse - optical tomography using a finite element model - -
    - Nuclear Science Symposium Record, vol. 4, pp. 2283-2285, 2005 -

    - -
  19. - Q. Ouyang, K. Xiu -
    - Simulation Study of Reduced Self-Heating in Novel - Thin-SOI Vertical Bipolar Transistors - -
    - Simulation of Semiconductor Processes and Devices, pp. 55-58, 2005 -

    - -
  20. - M. Polner -
    - Galerkin least-squares stabilization operators for the - Navier-Stokes equations, A unified approach - -
    - Ph.D. thesis, University of Twente, The Netherlands, 2005 -

    - -
  21. - R. B. Schulz, G. Echner, H. Ruehle, - W. Stroh, J. Vierling, T. Vogt, J. Peter, W. Semmler -
    - Development of a fully rotational non-contact fluorescence tomographer - for small animals - -
    - IEEE Micro-imaging Conference, IEEE Nuclear Science Symposium - Conference Record, pp. 2391-2393, 2005 -

    - - -
  22. - R. B. Schulz, J. Peter, W. Semmler, C. D'andrea, G. Valentini, R. Cubeddu -
    - Quantifiability and Image Quality in Noncontact Fluorescence Tomography - -
    - in: Photon Migration and Diffuse-Light Imaging II, K. Licha - and R. Cubeddu (eds.), SPIE press, 2005 -

    - -
- - - - -

Publications in 2004

- -
    -
  1. - W. Bangerth, -
    - A framework for the adaptive finite element solution - of large inverse problems. I. Basic techniques - -
    - ICES Report 2004-39, 2004. -

    - -
  2. - W. Bangerth, M. Grote, C. Hohenegger -
    - Finite Element Method For Time Dependent Scattering: - Nonreflecting Boundary Condition, Adaptivity, and Energy - Decay - -
    - Computer Methods in Applied Mechanics and Engineering, - vol. 193, pp. 2453-2482, 2004 -

    - -
  3. - D. Boffi, L. Gastaldi, L. Heltai -
    - A finite element approach to the immersed boundary method - -
    - Progress in Engineering Computational Technology, vol. 12, - pp. 271-298, 2004 -

    - - -
  4. - G. Carey, M. Anderson, B. Carnes, B. Kirk -
    - Some aspects of adaptive grid technology related to - boundary and interior layers - -
    - Journal of Computational and Applied Mathematics, vol. 166, - pp. 55-86, 2004 -

    - -
  5. - G. Carey, W. Barth, J. A. Woods, B. Kirk, - M. Anderson, S. Chow, W. Bangerth -
    - Modeling error and constitutive relations in - simulation of flow and transport - -
    - International Journal for Numerical Methods in Fluids, - vol. 46, pp. 1211-1236, 2004 -

    - -
  6. - S. Chow, G. F. Carey, M. L. Anderson -
    - Finite element approximations of a glaciology problem. - -
    - ESAIM: Mathematical Modelling and Numerical Analysis (M2AN), - vol. 38, pp. 741-756, 2004. -

    - -
  7. - R. Hartmann, P. Houston -
    - Goal-Oriented A Posteriori Error Estimation - for Multiple Target Functionals - -
    - in M. Feistauer, V. Doleji, P. Knobloch and K. Najzar, - editors, Numerical Mathematics and Advanced Applications, - ENUMATH 2003, pp. 410-419, Springer-Verlag, 2004 -
    - (BibTeX entry) -

    - -
  8. - U. Hasler, A. - Schneebeli, D. - Schötzau -
    - Mixed finite element approximation of incompressible - MHD problems based on weighted regularization - -
    - Applied Numerical Mathematics, vol. 51, pp. 19-45, 2004 -

    - -
  9. - A. Joshi, W. Bangerth, E. Sevick-Muraca -
    - Adaptive finite element modeling of optical - fluorescence-enhanced tomography - -
    - Optics Express, vol. 12, pp. 5402-5417, 2004 -

    - -
  10. - A. Joshi, A. B. Thompson, W. Bangerth, E. Sevick-Muraca -
    - Adaptive finite element methods for forward modeling - in fluorescence enhanced frequency domain optical tomography - -
    - Proceedings of the 2004 OSA Biomedical Topical Meetings, 2004 -

    - -
  11. - A. Joshi, W. Bangerth, A. B. Thompson, E. Sevick-Muraca -
    - Adaptive finite element methods for fluorescence - enhanced frequency domain optical tomography: Forward imaging - problem - -
    - Proceedings of the 2004 IEEE International Symposium on - Biomedical Imaging, 2004 -

    - -
  12. - G. Kanschat -
    - Multi-level methods for discontinuous Galerkin FEM on locally refined meshes -
    - Comput. & Struct., vol. 82, pp. 2437-2445, 2004 -

    - -
  13. - J. Ramirez, M. Laso -
    - Micro-macro simulations of three-dimensional plane - contraction flow - -
    - Modelling Simul. Mater. Sci. Eng., vol. 12, pp. 1293-1306, 2004 -

    - -
  14. - R. B. - Schulz, W. Bangerth, J. Peter, W. Semmler -
    - Independent modeling of - fluorescence excitation and emission with the finite element method - -
    - Proceedings - of the OSA BIOMED topical meeting, Miami, Florida, 14-18 April 2004 -

    - -
  15. - E. Zander, J. R. Weimar, H. G. Mathies -
    - Simulation of High-Frequency Atmospheric Gas Discharges - -
    - PAMM, vol. 4, pp. 428-429, 2004 -

    - -
- - - - -

Publications in 2003

- -
    -
  1. - S. Achatz -
    - Adaptive finite Dünngitter-Elemente höherer Ordnung - für elliptische partielle Differentialgleichungen mit variablen - Koeffizienten - -
    - Ph.D. thesis, TU Munich, 2003 -

    - -
  2. - W. Bangerth -
    - Starting threads in a C++ compatible fashion - -
    - C/C++ Users Journal, October 2003, pp. 21-24 -

    - -
  3. - W. Bangerth, R. Rannacher -
    - Adaptive Finite Element Methods for Solving Differential Equations - -
    - Book, Birkhäuser, 2003 -

    - -
  4. - M. Calhoun-Lopez -
    - Numerical solutions of hyperbolic conservation laws: - Incorporating multi-resolution viscosity methods into the - finite element framework - -
    - Ph.D. thesis, Iowa State University, 2003 -

    - -
  5. - B. Carnes -
    - Adaptive finite elements for nonlinear transport equations - -
    - Ph.D. thesis, ICES, The University of Texas at Austin, 2003 -

    - -
  6. - B. Cockburn, - G. Kanschat, - D. Schötzau -
    - LDG methods for Stokes flow problems -
    - in Brezzi, Buffa, Corsaro, Murli: Numerical Mathematics and Advanced Applications: - ENUMATH 2001, Springer Italia, 2003 -
    - (Abstract - ) -

    - -
  7. - B. Cockburn, - G. Kanschat, - D. Schötzau -
    - The Local Discontinuous Galerkin Method for the Oseen Equations -
    - Math. Comput., vol. 73, pp. 569-593, 2003 -
    - (Abstract) -

    - -
  8. - J. Gopalakrishnan, - G. Kanschat -
    - Application of unified DG analysis to preconditioning DG methods - -
    - in Bathe: Computational Fluid and Solid Mechanics, pp. 1943-1945, 2003 -

    - -
  9. - J. Gopalakrishnan, - G. Kanschat -
    - A Multilevel Discontinuous Galerkin Method - -
    - Numer. Math., vol. 95, pp. 527-550, 2003 -
    - (Abstract, - BibTeX - entry, - Postscript) -

    - -
  10. - Jay Gopalakrishnan, G. Kanschat -
    - Multi-level Preconditioners for the interior penalty method -
    - in Brezzi, Buffa, Corsaro, Murli: Numerical Mathematics and Advanced Applications: - ENUMATH 2001, Springer Italia, 2003 -
    - (Abstract) -

    - -
  11. - R. Hartmann, P. Houston -
    - Goal-Oriented A Posteriori Error Estimation - for Multiple Target Functionals - -
    - in T. Y. Hou and E. Tadmor, editors, Hyperbolic Problems: - Theory, Numerics, Applications, pp. 579-588, Springer, 2003 -
    - (Abstract, - BibTeX - entry) -

    - -
  12. - R. Hartmann, P. Houston -
    - Goal-Oriented A Posteriori Error Estimation for Compressible Fluid Flows - -
    - In F. Brezzi, A. Buffa, S. Corsaro and A. Murli, editors, - Numerical Mathematics and Advanced Applications, pp. 775-784, Springer, 2003 -
    - (Abstract, - BibTeX - entry) -

    - -
  13. - G. Kanschat -
    - Discontinuous Galerkin Finite Element Methods for Advection-Diffusion Problems -
    - Habilitationsschrift, Universität Heidelberg, 2003 -

    - -
  14. - G. Kanschat -
    - Preconditioning discontinuous Galerkin saddle point systems -
    - in Bathe: Computational Fluid and Solid Mechanics, pp. 2016-2018, 2003 -

    - -
  15. - G. Kanschat -
    - Preconditioning methods for local discontinuous {G}alerkin Discretizations -
    - SIAM J. Sci. Comput., vol. 25, pp. 815-831, 2003 -

    - - -
  16. - A. - Schneebeli, D. - Schötzau -
    - Mixed finite elements for incompressible magneto-hydrodynamics - -
    - Comptes Rendus Mathematique, vol. 337, pp. 71-74, 2003 -

    - -
  17. - M. Stadler, G. A. Holzapfel, J. Korelc -
    - Cn continuous modelling of smooth contact surfaces - using NURBS and application to 2D problems - -
    - International Journal for Numerical Methods in Engineering, - vol. 57, pp. 2177-2203, 2003 -

    - -
- - - -

Publications in 2002

- -
    - -
  1. - W. Bangerth -
    - Adaptive Finite Element Methods for the - Identification of Distributed Parameters in - Partial Differential Equations - -
    - Ph.D. thesis, University of Heidelberg, 2002 -
    - (Abstract, - BibTeX - entry) -

    - -
  2. - S. Benkler -
    - Numerical solution of the nonlinear Hartree equation. - -
    - Diploma thesis, ETH Zurich, Switzerland, 2002. -

    - -
  3. - B. Cockburn, - G. Kanschat, D. - Schötzau -
    - The local discontinuous Galerkin method in - incompressible fluid flow - -
    - in Mang, Rammerstorfer, Eberhardsteiner: Proceedings of the - Fifth World Congress on Computational Mechanics (WCCM V), - Vienna University of Technology, 2002 -
    - (Abstract, - BibTeX - entry, - Postscript) -

    - -
  4. - B. Cockburn, - G. Kanschat, D. - Schötzau, C. Schwab -
    - Local discontinuous Galerkin methods for the Stokes - system - -
    - SIAM J. Numer. Anal., vol. 40, pp. 319-343, 2002 -
    - (Abstract, - BibTeX - entry, - Postscript) -

    - -
  5. - R. Hartmann -
    - Adaptive Finite Element Methods for the Compressible - Euler Equations - -
    - Ph.D. thesis, University of Heidelberg, 2002 -
    - (Abstract, - BibTeX entry) -

    - -
  6. - R. Hartmann, P. Houston -
    - Adaptive Discontinuous Galerkin Finite Element - Methods for the Compressible Euler Equations - -
    - J. Comput. Phys., vol. 183, pp. 508-532, 2002. -
    - (Abstract, - BibTeX - entry) -

    - -
  7. - R. Hartmann, P. Houston -
    - Adaptive Discontinuous Galerkin Finite Element - Methods for Nonlinear Hyperbolic Conservation Laws - -
    - SIAM J. Sci. Comput., vol. 24, pp. 979-1004, 2002. -
    - (Abstract, - BibTeX - entry) -

    - -
  8. - G. Kanschat, Rolf Rannacher -
    - Local error analysis of the interior penalty - discontinuous Galerkin method for second order elliptic problems - -
    - J. Numer. Math., vol. 10, pp. 249-274, 2002 -
    - (Abstract, - BibTeX - entry, - Postscript) -

    - -
  9. - F. Mohamed, M. Troyer, G. Blatter -
    - Interaction of vortices in superconductors with - kappa close to 1/sqrt(2), - -
    - Phys. Rev. B, vol. 65, article 224504, 2002. -

    - - -
  10. - T. Shardlow -
    - A coupled Cahn-Hilliard particle system - -
    - Electronic Journal of Differential Equations, - vol. 2002, No. 73, pp. 1-21, 2002 -

    - - -
  11. - M. Stadler, G. A. Holzapfel -
    - A novel approach for smooth contact surfaces using NURBS: - application to the FE simulation of stenting - -
    - Proceedings of the 13th Conference of the European Society of - Biomechanics, 1-4 September 2002, Wroclaw, Poland. -

    - -
- - - - -

Publications in 2001

- -
    -
  1. - A. Barinka, T. Barsch, P. Charton, A. Cohen, S. Dahlke, - W. Dahmen, K. Urban -
    - Adaptive wavelet schemes for elliptic - problems—implementation and numerical experiments - -
    - SIAM J. Sci. Comput., - vol. 23, pp. 910-939, 2001 -

    - -
  2. - B. Cockburn, G. Kanschat, Ilaria Perugia, D. - Schötzau -
    - Superconvergence of the Local Discontinuous Galerkin - Method for Elliptic Problems on Cartesian Grids - -
    - SIAM J. Numer. Anal. 39 (1), pp. 264-285, 2001 -
    - (Abstract, - BibTeX - entry, - Postscript) -

    - -
  3. - T. Richter -
    - Funktionalorientierte Gitteroptimierung bei der Finite-Elemente - Approximation elliptischer Differentialgleichungen - -
    - Diploma thesis, University of Heidelberg, 2001 (in German)
    - (Abstract) -

    -
- - - -

Publications in 2000

- -
    - -
  1. - W. Bangerth -
    - Mesh Adaptivity and Error Control for a Finite Element - Approximation of the Elastic Wave - Equation - -
    - Proceedings of the Waves2000 conference, - held in Santiago de Compostela, Spain, July 10-14, 2000 -
    - (Abstract, - BibTeX - entry) -

    - -
  2. - W. Bangerth -
    - Multi-threading support in deal.II - -
    - Preprint 2000-11 (SFB 359), IWR Heidelberg, October 1999. -
    - This paper is also available - online. -
    - (Abstract, - BiBTeX entry) -

    - -
  3. - W. Bangerth -
    - Using Modern Features of C++ for Adaptive Finite - Element Methods: - Dimension-Independent Programming in deal.II - -
    - Proceedings of the 16th IMACS World - Congress, Lausanne, Switzerland, 2000 -
    - This paper is also available - online. -
    - (Abstract, - BibTeX entry) -

    - -
  4. - R. Hartmann -
    - Adaptive FE-Methods for Conservation Equations - -
    - In Heinrich Freistühler and Gerald Warnecke, eds. - Hyperbolic problems: theory, numerics, applications: - eighth international conference in Magdeburg, 2000. -
    - International series of numerical mathematics 141: 495-503. - Birkhäuser, Basel 2001. -
    - (Abstract, - BibTeX - entry) -

    - -
  5. - F. Mohamed -
    - Interaction of vortices in superconductors with - kappa close to 1/sqrt(2), - -
    - Diploma thesis, ETH Zurich, 2000. -

    - -
- - - - -

Publications in 1999

- -
    -
  1. - W. Bangerth and - G. Kanschat -
    - Concepts for object-oriented finite element - software - the deal.II library - -
    - Preprint 99-43 (SFB 359), IWR Heidelberg, October 1999. -
    - (Abstract, - BibTeX - entry) -

    - -
  2. - W. Bangerth, R. Rannacher -
    - Adaptive finite element approximation of the acoustic wave - equation: Error estimation and mesh adaptation - -
    - East-West Journal of Numerical Mathematics, vol. 7, no. 4 (1999), - pp. 263-282 -
    - (Abstract, - BibTeX - entry) -

    -
  3. - W. Bangerth, R. Rannacher -
    - Adaptive finite element techniques for the acoustic - wave equation - -
    - Journal of Computational Acoustics, vol. 9, no. 2 - (2001), pp. 575-591 -
    - (Abstract, - BibTeX - entry) -

    - -
  4. - S. Nauber -
    - Adaptive Finite Elemente Verfahren für - selbstadjungierte Eigenwertprobleme - -
    - Diploma thesis, University of Heidelberg, 1999 (in German) -

    - -
- - - - - - - - -

Publications in 1998

- -
    -
  1. - W. Bangerth -
    - Adaptive Finite-Elemente-Methoden zur Lösung der - Wellengleichung mit Anwendung in der Physik der Sonne - -
    - Diploma thesis, University of Heidelberg, 1998 (in German) -
    - (Abstract, - BibTeX entry) -

    -
- - - -
- -
- The deal.II mailing list
- - - - diff --git a/deal.II/doc/readme.html b/deal.II/doc/readme.html index c8596bb1d4..05834dcf63 100644 --- a/deal.II/doc/readme.html +++ b/deal.II/doc/readme.html @@ -790,7 +790,7 @@ libraries we create. To this end, we collect publications with results obtained using deal.II. Please let us know if you have publications that we can add - to this page. + to this page.

@@ -823,7 +823,7 @@
  • We ask that scientific publications presenting results obtained with this libraries acknowledge its use. Please cite one of the papers referenced - here. + here.

    -- 2.39.5