<html>
<head>
- <link href="../screen.css" rel="StyleSheet" media="screen">
+ <meta http-equiv="refresh" content="0;url=http://www.dealii.org/developer/publications/index.html">
<title>The deal.II Publication List</title>
<meta name="copyright" content="Copyright (C) 1998 - 2013 by the deal.II Authors">
- <meta name="keywords" content="dealII publications">
- <meta http-equiv="Content-type" content="text/html;charset=UTF-8">
- <style type="text/css">
- li { margin-bottom: 1ex; }
- </style>
</head>
<body>
-
-
- <h1>Publications on and with <acronym>deal.II</acronym></h1>
-
- <p>
- 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
- <acronym>deal.II</acronym>. 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.
- </p>
-
- <p align="left">
- <table class="tutorial">
- <tr>
- <th><b><small>Table of contents</small></b></th>
- </tr>
-
- <tr>
- <td valign="top">
- <ol>
- <li> <a href="#referencing"
- >Referencing <acronym>deal.II</acronym></a>
- <li> <a href="#details">Publications on details
- of <acronym>deal.II</acronym></a>
- <li> Publications per year:<br>
- <a href="#2010">2010</a>
- <a href="#2011">2011</a>
- <a href="#2012">2012</a>
- <a href="#2013">2013</a>
- <br>
- <a href="#2000">2000</a>
- <a href="#2001">2001</a>
- <a href="#2002">2002</a>
- <a href="#2003">2003</a>
- <a href="#2004">2004</a>
- <a href="#2005">2005</a>
- <a href="#2006">2006</a>
- <a href="#2007">2007</a>
- <a href="#2008">2008</a>
- <a href="#2009">2009</a>
- <br>
- <a href="#1998">1998</a>
- <a href="#1999">1999</a>
- </ol>
- </td>
- </tr>
- </table>
-
-
- <a name="referencing"> </a>
- <h2>Referencing <acronym>deal.II</acronym></h2>
-
- <p>
- If you write a paper using results obtained with the help of
- <acronym>deal.II</acronym>, please cite one or both of the following
- references:
- </p>
-
- <ol>
- <li> <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>,
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a> and
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>
- deal.II — a general-purpose object-oriented finite element library
- </strong>
- <br>
- ACM Transactions on Mathematical Software, vol. 33, no. 4, article 24
- <br>
- DOI <a href="http://doi.acm.org/10.1145/1268776.1268779">10.1145/1268776.1268779</a>
- (<a
- href="http://www.isc.tamu.edu/publications-reports/tr/0602.pdf">Preprint</a>)
- <br>
-<pre>
-@Article{BangerthHartmannKanschat2007,
- author = {W. Bangerth and R. Hartmann and G. 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}
-}
-</pre>
- </li>
- <li>
- Wolfgang Bangerth, Timo Heister, Luca Heltai, Guido Kanschat, Martin Kronbichler, Matthias Maier, and Toby D. Young <br/>
- <strong>The <acronym>deal.II</acronym> Library, Version 8.0
- </strong>
- <br>
- <a href="http://arxiv.org/abs/1312.2266" target="_top">arxiv:1312.2266</a>, 2013.
- <br>
-<pre>
-@article{dealII80,
- title = {The {\tt deal.{I}{I}} Library, Version 8.0},
- author = {W. Bangerth and T. Heister and L. Heltai and G. Kanschat
- and M. Kronbichler and M. Maier and B. Turcksin and T. D. Young},
- journal = {arXiv preprint \url{http://arxiv.org/abs/1312.2266}},
- year = {2013},
-}
-</pre>
- </li>
- </ol>
-
- <p>
- For your convenience, we provide a <a href="dealii.bib">BibTeX file</a> with entries
- for the publications in this section.
- </p>
-
-
-
- <!-- check on Freddi papers, conference at http://www.eurosim2007.org -->
- <!-- watch for the papers here -->
- <!-- http://www-sop.inria.fr/tosca/personnel/Claire.Chauvin/ to appear -->
- <!-- check GAKUTO (and possibly other papers by Natalini at
- http://www.iac.cnr.it/~natalini/papers.html -->
-
- <!-- Check Martin Steigemann papers
- http://www.martin-steigemann.net/index_uni_kassel.html
- Pieter Ghysels
- R. Ziegler -->
-
- <a name="details"> </a>
- <h4>Publications on details of <acronym>deal.II</acronym></h4>
-
<p>
- The following publications explain in great detail the
- implementation of algorithms and data structures of the hp, multigrid,
- distributed mesh, and matrix-free components of deal.II:
- </p>
-
- <ol>
- <li>
- B. Janssen,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>,
- <br>
- <strong>Adaptive Multilevel Methods with Local Smoothing for H<sup>1</sup>-
- and H<sup>curl</sup>-Conforming High Order Finite Element Methods</strong>
- <br>
- SIAM J. Sci. Comput., vol. 33/4, pp. 2095-2114, 2011
- <br>
- DOI: <a href="http://dx.doi.org/10.1137/090778523">10.1137/090778523</a>
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>,
- <a href="http://users.ices.utexas.edu/~carsten/"
- target="_top">C. Burstedde</a>,
- T. Heister,
- M. Kronbichler
- <br>
- <strong>Algorithms and Data Structures for Massively Parallel Generic
- Finite Element Codes</strong>
- <br>
- ACM Trans. Math. Softw., vol. 38, pp. 14/1-28, 2011.
- <br>
- DOI: <a href="http://dx.doi.org/10.1145/2049673.2049678">10.1145/2049673.2049678</a>
-
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, O. Kayser-Herold,
- <br>
- <strong>Data Structures and Requirements for hp Finite Element
- Software
- </strong>
- <br>
- ACM Trans. Math. Softw., vol. 36, pp. 4/1-31, 2009
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>Multi-level methods for discontinuous Galerkin FEM on locally refined meshes</strong>
- <br>
- Comput. & Struct., vol. 82, pp. 2437-2445, 2004
- </li>
-
- <li> M. Kronbichler, K. Kormann
- <br>
- <strong>A generic interface for parallel cell-based finite element
- operator application
- </strong>
- <br>
- Computers and Fluids, vol. 63, pp. 135-147, 2012
- <br>
- DOI: <a href="http://dx.doi.org/10.1016/j.compfluid.2012.04.012">10.1016/j.compfluid.2012.04.012</a>
- </li>
-
- <li> W. Bangerth, T. Heister
- <br>
- <strong>What makes computational open source software libraries successful?</strong>
- <br>
- Computational Science & Discovery, vol. 6, article 015010, 2013.
- </li>
- </ol>
-
- <p> For massively parallel
- computations, <acronym>deal.II</acronym> builds on the
- <a href="http://www.p4est.org/" target="_top">p4est</a>
- library. If you use this functionality, please also cite the
- p4est paper listed at their website.
+ The updated list is available at
+ <a href="http://www.dealii.org/developer/publications/index.html">http://www.dealii.org/developer/publications/index.html</a>.
</p>
- <p>
- <acronym>deal.II</acronym> is a component of the <a
- href="http://www.spec.org/cpu2006/">SPEC CPU2006</a> 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 <acronym>deal.II</acronym>:
- <ul>
- <li>
- <strong>Special Issue: SPEC CPU2006 analysis (Editor: John Henning)
- </strong>
- <br>
- ACM SIGARCH Computer Architecture News, vol. 35, issue 1, 2007.
- </li>
- </ul>
-
-
-
- <a name="2014"> </a>
- <h2>Publications in 2014</h2>
-
- <!-- Please enter alphabetically by name -->
- <ol>
- <li> T. Wick, G. Singh, M.F. Wheeler
- <br>
- <strong>Pressurized-Fracture propagation using a phase-field approach coupled to a reservoir simulator
- </strong>
- <br>
- SPE 168597-MS, SPE HFTC Proc. 2014.
- </li>
- </ol>
-
-
- <a name="2013"> </a>
- <h2>Publications in 2013</h2>
-
- <!-- Please enter alphabetically by name -->
- <ol>
- <li> M. Alexe, A. Sandu
- <br>
- <strong>Space-time adaptive solution of inverse problems with the
- discrete adjoint method
- </strong>
- <br>
- submitted, 2013.
- </li>
-
- <li> G. Alam
- <br>
- <strong>Fast iterative solution of large scale statistical
- inverse problems
- </strong>
- <br>
- Master Thesis, Stockholm University, 2013.
- </li>
-
- <li> J. C. Araujo-Cabarcas
- <br>
- <strong>Numerical methods for glacial isostatic adjustment models
- </strong>
- <br>
- MSc thesis, Uppsala University, Uppsala, Sweden, 2013.
- </li>
-
- <li> P. Argul, G. Ruocci, F. Freddi, K. Benzarti
- <br>
- <strong>An improved damage modelling to deal with the variability of
- fracture mechanisms in FRP reinforced concrete structures
- </strong>
- <br>
- International Journal of Adhesion and Adhesives 45 , 7-20, 2013.
- </li>
-
- <li> D. Arndt
- <br>
- <strong>Augmented Taylor-Hood Elements for Incompressible Flow
- </strong>
- <br>
- Msc thesis, University of Göttingen, Germany, 2013.
- </li>
-
- <li> O. Axelsson, P. Boyanova, M. Kronbichler, M. Neytcheva, X. Wu
- <br>
- <strong>Numerical and computational efficiency of solvers for
- two-phase problems
- </strong>
- <br>
- Comput. Math. Appl., 65, 301-314, 2013.
- </li>
-
- <li> A. Barker, T. Rees, M. Stoll
- <br>
- <strong>A fast solver for an H<sub>1</sub> regularized
- PDE-constrained optimization problem</strong>
- <br>
- submitted, 2013.
- </li>
-
- <li> W. Bangerth, T. Heister
- <br>
- <strong>What makes computational open source software libraries successful?</strong>
- <br>
- Computational Science & Discovery, vol. 6, article 015010, 2013.
- </li>
-
- <li> S. Bartels, R. H. Nochetto, A. J. Salgado
- <br>
- <strong>A total variation diminishing interpolation operator
- and applications</strong>
- <br>
- submitted, 2013.
- </li>
-
- <li> P. Benner, M. Stoll
- <br>
- <strong>Optimal control for Allen-Cahn equations enhanced by model predictive control</strong>
- <br>
- Preprint, MPI Magdeburg, 2013.
- </li>
-
-
- <li> A. Bonito, D. Devaud
- <br>
- <strong>Adaptive Finite Element Methods for the Stokes Problems with Discontinuous Coefficients</strong>
- <br>
- submitted, 2013.
- </li>
-
- <li> A. Bonito, R. DeVore, R. H. Nochetto
- <br>
- <strong>Adaptive Finite Element Methods for Elliptic Problems with Discontinuous Coefficients</strong>
- <br>
- SIAM J. Numer. Anal. 51 (2013), no. 6, 3106--3134.
- </li>
-
- <li> A. Bonito, R. Glowinski
- <br>
- <strong>On the Nodal Set of the Eigenfunctions of the Laplace-Beltrami Operator for Bounded Surfaces in R3: A Computational Approach</strong>
- <br>
- submitted, 2013.
- </li>
-
- <li> A. Bonito, J.-L. Guermond, S. Lee
- <br>
- <strong>Two Modified Pressure-Correction Projection Methods for the Time-Dependent Stokes Equations</strong>
- <br>
- submitted, 2013.
- </li>
-
- <li> A. Bonito, I. Kyza, R. H. Nochetto
- <br>
- <strong>A dG Approach to Higher Order ALE Formulations in Time
- </strong>
- <br>
- 2012 Barrett Lectures, The IMA Volume in Mathematics and its Applications, Vol. 157, 36 pages, 2013, Springer.
- </li>
-
- <li> A. Bonito, I. Kyza, R. H. Nochetto
- <br>
- <strong>Time-discrete higher order ALE formulations: A
- priori error analysis</strong>
- <br>
- Numer. Math., 23 pages, 2013, 10.1007/s00211-013-0539-3.
- </li>
-
- <li> A. Bonito, I. Kyza, R. H. Nochetto
- <br>
- <strong>Time-discrete higher order ALE formulations: Stability</strong>
- <br>
- SIAM J. Numer. Anal., 51(1), 577--608, 2013.
- </li>
-
- <li> A. Bonito, J. E. Pasciak
- <br>
- <strong>Numerical Approximation of Fractional Powers of Elliptic Operators</strong>
- <br>
- submitted, 2013.
- </li>
-
- <li> J. Bosch, M. Stoll, P. Benner
- <br>
- <strong>Fast solution of Cahn-Hilliard variational
- inequalities using implicit time discretizations and finite
- elements</strong>
- <br>
- Preprint 13/01, MPI Magdeburg, 2013.
- </li>
-
- <li> J. Bosch, D. Kay, M. Stoll, A. J. Wathen
- <br>
- <strong>Fast solvers for Cahn-Hilliard inpainting</strong>
- <br>
- Technical report 1705, The Mathematical Institute,
- University of Oxford; submitted, 2013.
- </li>
-
- <li> A. Cangiani, J. Chapman, E. Georgoulis, M. Jensen
- <br>
- <strong>Implementation of the Continuous-Discontinuous
- Galerkin Finite Element Method</strong>
- <br>
- Numerical Mathematics and Advanced Applications 2011,
- pp. 315-322, 2013.
- </li>
-
- <li> T. Carraro, J. Joos
- <br>
- <strong>Parameter estimation for a reconstructed SOFC
- mixed-conducting LSCF-cathode</strong>
- <br>
- Model Based Parameter Estimation, H. G. Bock et al., eds.,
- pp. 267-285, Springer, 2013.
- </li>
-
- <li> T. Carraro, C. Goll, A. Marciniak-Czochra, A. Mikelic
- <br>
- <strong>Pressure jump interface law for the Stokes-Darcy
- coupling: Confirmation by direct numerical simulation</strong>
- <br>
- arXiv:1301.6580v0, 2013.
- </li>
-
- <li> C.-C. Chueh, N. Djilali, W. Bangerth
- <br>
- <strong>An h-adaptive Operator Splitting Method for
- Two-phase Flow in 3D Heterogeneous Porous Media</strong>
- <br>
- SIAM Journal on Scientific Computing, vol. 35, pp. B149-175, 2013.
- </li>
-
- <li> D. Devaud
- <br>
- <strong>Adaptive Methods for the Stokes System with Discontinuous Viscosities
- </strong>
- <br>
- MSc thesis, EPFL, 2013.
- </li>
-
- <li> T. Dohnal, W. Dörfler
- <br>
- <strong>Coupled Mode Equation Modeling for Out-of-Plane Gap
- Solitons in 2D Photonic Crystals</strong>
- <br>
- Multiscale Modeling and Simulation, vol. 11, pp. 162-191, 2013.
- </li>
-
- <li> I. Donev
- <br>
- <strong>Time Dependent Finite Element Simulations of a Generalized Oldroyd-B Fluid
- </strong>
- <br>
- MSc Thesis, University of Cape Town, 2013.
- </li>
-
- <li> W. Dörfler, S. Findeisen
- <br>
- <strong>Numerical optimization of a waveguide transition
- using finite element beam propagation</strong>
- <br>
- IWRMM, Preprint 13/01, Karlsruhe Institute of Technology,
- 2013.
- <!-- http://www.math.kit.edu/ianm2/~doerfler/seite/pub/de -->
- </li>
-
- <li> K. Dugan
- <br>
- <strong>Dynamic adaptive multimesh refinement for coupled
- physics applicable to nuclear engineering
- </strong>
- <br>
- MSc thesis, Texas A&M University, 2013.
- </li>
-
- <li> Y. Efendiev, J. Galvis, S. Pauletti
- <br>
- <strong>Multiscale finite element methods for flows on rough
- surfaces
- </strong>
- <br>
- Communications in Computational Physics, accepted, 2013.
- </li>
-
- <li> E. Emmrich, A. Wróblewska-Kamińska
- <br>
- <strong>Convergence of a Full Discretization of Quasi-linear Parabolic Equations in Isotropic and Anisotropic Orlicz Spaces
- </strong>
- <br>
- SIAM Journal on Numerical Analysis, vol. 51, pp. 1163-1184, 2013.
- </li>
-
- <li> J. Fang, X. Gao, A. Zhou
- <br>
- <strong>A finite element recovery approach to eigenvalue
- approximations with applications to electronic structure
- calculations
- </strong>
- <br>
- Journal of Scientific Computing, vol. 55, pp. 432-454, 2013.
- </li>
-
- <li> T. Fankhauser, T. Wihler, M. Wirz
- <br>
- <strong>The hp-adaptive FEM based on continuous Sobolev embeddings: Isotropic
- refinements</strong>
- <br>
- Computers & Mathematics with Applications (in press), 2013.
- </li>
-
- <li> F. Freddi, G. Royer-Carfagni
- <br>
- <strong>Plastic flow as an energy minimization problem. Numerical
- Experiments
- </strong>
- <br>
- Journal of Elasticity, in press, 2013.
- </li>
-
- <li> S. Frei, T. Richter, T. Wick
- <br>
- <strong>Eulerian Techniques for Fluid-Structure Interactions - Part
- I: Modeling and Simulation
- </strong>
- <br>
- ENUMATH Proc., submitted Nov 2013.
- </li>
-
- <li> S. Frei, T. Richter, T. Wick
- <br>
- <strong>Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications
- </strong>
- <br>
- ENUMATH Proc., submitted Nov 2013.
- </li>
-
- <li> A. Geringer, B. Lenhof, S. Diebels
- <br>
- <strong>Macroscopic modeling of foams: an order-parameter
- approach vs. a micropolar model
- </strong>
- <br>
- Technische Mechanik, vol. 33, pp. 87-96, 2013.
- </li>
-
- <li> F. Gimbel
- <br>
- <strong>Modelling and numerical simulation of contact and lubrication
- </strong>
- <br>
- PhD thesis, University of Siegen, Germany, 2013.
- </li>
-
- <li> C. Goll, R. Rannacher, W. Wollner
- <br>
- <strong>Goal-Oriented Mesh Adaptation in the Space-Time
- Finite Element Approximation of the Black-Scholes Equation
- </strong>
- <br>
- Journal of Computational Finance, accepted, 2013.
- </li>
-
- <li> S. Härting, A. Marciniak-Czochra
- <br>
- <strong>Spike patterns in a reaction-diffusion-ode model with Turing instability</strong>
- <br>
- arXiv:1303.5362, submitted, 2013.
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Higher-order and adaptive discontinuous Galerkin
- methods with shock-capturing applied to transonic turbulent
- delta wing flow
- </strong>
- <br>
- International Journal for Numerical Methods in Fluids,
- vol. 72, pp. 883-894, 2013.
- </li>
-
- <li> T. Heister, G. Rapin
- <br>
- <strong>Efficient augmented Lagrangian-type preconditioning
- for the Oseen problem using Grad-Div stabilization</strong>
- <br>
- Int. J. Num. Meth. Fluids, 71, 118–134, 2013
- (<a href="http://dx.doi.org/10.1002/fld.3654">DOI</a>)
- </li>
-
- <li> M. Hinze, U. Mathes
- <br>
- <strong>Model order reduction for networks of ODE and PDE systems
- </strong>
- <br>
- System Modeling and Optimization, IFIP Advances in
- Information and Communication Technology Volume 391,
- pp 92-101, 2013.
- </li>
-
- <li> S. Joshi, J, Walton
- <br>
- <strong>Reconstruction of the residual stresses in a hyperelastic body using ultrasound techniques
- </strong>
- <br>
- International Journal on Engineering Science, vol. 70,
- pp. 46-72, 2013.
- </li>
-
- <li> S. Kim
- <br>
- <strong>Analysis of the convected Helmholtz equation with a
- uniform mean flow in a waveguide with complete radiation
- boundary conditions
- </strong>
- <br>
- Journal of Mathematical Analysis and Applications,
- in press,
- <!-- http://www.sciencedirect.com/science/article/pii/S0022247X1300749X -->
- 2013.
- </li>
-
- <li> N. Klein
- <br>
- <strong>Consistent FE-Analysis of elliptic Variational Inequalities
- </strong>
- <br>
- PhD thesis, University of Siegen, Germany, 2013.
- </li>
-
- <li> T. Krüger
- <br>
- <strong>Regularization-based fictitious domain methods
- </strong>
- <br>
- PhD thesis, University of Siegen, Germany, 2013.
- </li>
-
- <li> K. Kumar, T. van Noorden, M. F. Wheeler, T. Wick
- <br>
- <strong>An ALE-based method for reaction-induced boundary movement towards clogging
- </strong>
- <br>
- ENUMATH Proc., submitted Nov 2013.
- </li>
-
- <li> K. Kumar, M.F. Wheeler, T. Wick
- <br>
- <strong>Reactive flow reaction-induced boundary movement in
- a thin channel
- </strong>
- <br>
- SIAM J. Sci. Comput. 35(6), pp. B1235-B1266, 2013
- </li>
-
- <li> B. Lenhof, A. Geringer, S. Diebels
- <br>
- <strong>Macroscopic modeling of size effects in foams using
- an order parameter
- </strong>
- <br>
- Generalized Continua as Models for Materials,
- Advanced Structured Materials, vol. 22, pp. 237-254, 2013.
- </li>
-
- <li> S. H. Lim
- <br>
- <strong>Numerical Simulation of Two-phase Heat Flow and Transient
- Partial Melting in the Lower Crust with Adaptive Mesh Refinement
- </strong>
- <br>
- Undergraduate honors thesis, University of Michigan, Ann Arbor, 2013.
- </li>
-
- <li> A. Mikelic, M.F. Wheeler, T. Wick
- <br>
- <strong>A phase field approach to the fluid filled fracture surrounded by a poroelastic medium
- </strong>
- <br>
- submitted, ICES preprint on http://www.ices.utexas.edu/research/reports/
- </li>
-
- <li> A. Mola, L. Heltai, A. DeSimone
- <br>
- <strong>A stable and adaptive semi-Lagrangian potential
- model for unsteady and nonlinear ship-wave
- interactions</strong>
- <br>
- Engineering Analysis with Boundary Elements, vol. 37,
- pp. 128-143, 2013.
- </li>
-
- <li> R. H. Nochetto, A. J. Salgado, I. Tomas
- <br>
- <strong>The micropolar Navier-Stokes equations: A priori error analysis</strong>
- <br>
- arXiv:1303.7005, submitted, 2013.
- </li>
-
- <li> T. Povall
- <br>
- <strong>Single Crystal Plasticity at Finite Strains: A Computational Investigation of Hardening Relations</strong>
- <br>
- MSc Thesis, University of Cape Town, 2013.
- </li>
-
- <li> T. Reis, W. Wollner
- <br>
- <strong>Iterative solution of operator Lyapunov equations
- arising in heat transfer
- </strong>
- <br>
- 2013 European Control Conference, Zurich Switzerland,
- pp. 41-46, 2013.
- </li>
-
- <li> T. Richter, T. Wick
- <br>
- <strong>Solid growth and clogging in fluid-structure interaction computed in ALE and fully Eulerian coordinates
- </strong>
- <br>
- submitted Oct 2013 (peer-reviewed journal)
- </li>
-
- <li> T. Richter, T. Wick
- <br>
- <strong>On time discretizations of fluid-structure interactions
- </strong>
- <br>
- submitted Oct 2013 (book proceedings)
- </li>
-
-
- <li> T. Richter, T. Wick
- <br>
- <strong>Optimal Control and Parameter Estimation for Stationary Fluid-Structure Interaction Problems
- </strong>
- <br>
- SIAM J. Sci. Comput., accepted in May, 2013.
- </li>
-
- <li> S. Roy, L. Heltai, D. Drapaca, F. Costanzo
- <br>
- <strong>An immersed finite element method approach for brain biomechanics</strong>
- <br>
- Mechanics of Biological Systems and Materials, Volume 5,
- Conference Proceedings of the Society for Experimental Mechanics
- Series, pp. 79-86, 2013.
- </li>
-
- <li> J. Reinhardt, F. Weysser, J. M. Brader
- <br>
- <strong>Density functional approach to nonlinear rheology</strong>
- <br>
- Europhysics Letters, vol. 102, article 28011, 2013.
- </li>
-
- <li> S. Rudraraju, K. L. Mills, R. Kemkemer, K. Garikipati
- <br>
- <strong>Multiphysics Modeling of Reactions, Mass Transport and Mechanics of Tumor Growth
- </strong>
- <br>
- Computer Models in Biomechanics, G. Holzapfel and E. Kuhl
- (eds.), Spinger Verlag, pp. 293-303, 2013.
- </li>
-
- <li> M. Sagebaum, N. R. Gauger, U. Naumann, J. Lotz, K. Leppkes
- <br>
- <strong>Algorithmic differentiation of a complex C++ code with underlying libraries
- </strong>
- <br>
- Procedia Computer Science, vol. 18, pp. 208-217, 2013.
- </li>
-
- <li> P. Siehr
- <br>
- <strong>Stabilisierungsmethoden für die Stokes-Gleichungen
- </strong>
- <br>
- Bachelor thesis, University of Heidelberg, Germany, 2013.
- </li>
-
- <li>
- M. Steigemann, B. Schramm
- <br>
- <strong>Precise computation and error control of stress
- intensity factors and certain integral characteristics in
- anisotropic inhomogeneous materials
- </strong>
- <br>
- International Journal of Fracture, vol. 182, pp. 67-91, 2013.
- </li>
-
- <li> M. Stoll, T. Breiten
- <br>
- <strong>A low-rank in time approach to PDE-constrained optimization</strong>
- <br>
- Max Planck Institute Magdeburg, Preprint MPIMD/13-08, 2013.
- </li>
-
- <li> N. Vakulin, R. Shaw, T. Livingston
- <br>
- <strong>ELEC 490, final report: High performance computing with GPUs
- </strong>
- <br>
- Semester project for ELEC 490, final report. Queen's University,
- 2013
- </li>
-
- <li> A. Vidal-Ferrandiz, R. Fayez, D. Ginestar, G. Verdú
- <br>
- <strong>Solution of the Lambda modes problem of a nuclear
- power reactor using an h-p finite element method
- </strong>
- <br>
- Conference abstract, Mathematical Modelling in Engineering &
- Human Behaviour 2013, 2013.
- </li>
-
- <li> T. Wick, A. H. Elsheikh, M.F. Wheeler
- <br>
- <strong>Parameter Estimation for the Coupled Biot-Lam\'e-Navier Problem in Subsurface Modeling
- </strong>
- <br>
- ARMA Conference in San Francisco, Jun 23-26, 2013.
- </li>
-
-
-
- <li> J. Weinbub, K. Rupp, S. Selberherr
- <br>
- <strong>ViennaX: a parallel plugin execution framework for
- scientific computing
- </strong>
- <br>
- Engineering with Computers, DOI 10.1007/s00366-013-0314-1, February 2013.
- </li>
-
- <li> T. Wick
- <br>
- <strong>Flapping and Contact FSI Computations with the
- Fluid-Solid Interface-Tracking/Interface-Capturing Technique
- and Mesh Adaptivity
- </strong>
- <br>
- Computational Mechanics, DOI: 10.1007/s00466-013-0890-3, 2013.
- </li>
-
- <li> T. Wick
- <br>
- <strong>Coupling of fully Eulerian and arbitrary Lagrangian-Eulerian
- methods for fluid-structure interaction computations
- </strong>
- <br>
- Computational Mechanics, DOI: 10.1007/s00466-013-0866-3, 2013.
- </li>
-
- <li> T. Wick
- <br>
- <strong>Solving monolithic fluid-structure interaction
- problems in arbitrary
- Lagrangian Eulerian coordinates
- with the deal.II library
- </strong>
- <br>
- ANS, vol. 1, pp. 1-19, 2013. http://www.archnumsoft.org/
- </li>
-
- <li> T. Wick
- <br>
- <strong>Fully Eulerian fluid-structure interaction for time-dependent problems
- </strong>
- <br>
- Comp. Methods Appl. Mech. Engrg., vol. 255, pp. 14-26, 2013.
- </li>
-
- <li> J. Willems
- <br>
- <strong>Robust Multilevel Solvers for High-Contrast Anisotropic
- Multiscale Problems
- </strong>
- <br>
- Journal of Computational and Applied Mathematics, 251:47-60, 2013, doi:10.1016/j.cam.2013.03.030.
- </li>
-
- <li> J. Willems
- <br>
- <strong>Spectral Coarse Spaces in Robust Two-Level Schwartz Methods
- </strong>
- <br>
- O. Iliev, S. Margenov, P. Minev, P. Vassilevski, L. Zikatanov, editors, Numerical Solution of Partial Differential Equations: Theory, Algorithms and their Applications, 303-326, Springer Proceedings in Mathematics & Statistics, Springer, 2013.
- </li>
-
- <li> S. Yoon, Y. T. Kang
- <br>
- <strong>Mass transfer enhancement in non-Brownian particle
- suspension under a confined shear</strong>
- <br>
- International Journal of Heat and Mass Transfer, vol. 60,
- pp. 114-124, 2013.
- </li>
-
- <li> <a href="http://www.ippt.gov.pl/~tyoung"
- target="_top">T. D. Young</a>
- <br>
- <strong>A finite basis grid analysis of the Hartree-Fock wavefunction method for one- and two-electron atoms
- </strong>
- <br>
- AIP Conf. Proc., vol. 1558, pp. 1524, 2013.
- </li>
-
- <li> <a href="http://www.ippt.gov.pl/~tyoung"
- target="_top">T. D. Young</a>, E. Romero, J. E. Roman
- <br>
- <strong>Parallel finite element density functional theory exploiting grid refinement and subspace recycling
- </strong>
- <br>
- Comput. Phys. Commun., vol. 184, 1, pp. 66-72, 2013.
- </li>
-
- <li> V. Zingan, J.-L. Guermond, J. Morel, B. Popov
- <br>
- <strong>Implementation of the entropy viscosity method with
- the Discontinuous Galerkin Method
- </strong>
- <br>
- Computer Methods in Applied Mechanics and Engineering,
- vol. 253, pp. 479-490, 2013.
- </li>
- </ol>
-
- <a name="2012"> </a>
- <h2>Publications in 2012</h2>
-
- <!-- Please enter alphabetically by name -->
- <ol>
- <li> M. Bause, U. Köcher
- <br>
- <strong>Numerical simulation of elastic wave propagation
- in composite material</strong>
- <br>
- Proceedings of the European Congress on Computational Methods
- in Applied Sciences and Engineering (ECCOMAS 2012)
- J. Eberhardsteiner et.al. (eds.)
- Vienna, Austria, September 10-14, 2012.
- </li>
-
- <li> M. Besier, W. Wollner
- <br>
- <strong>On the pressure approximation in nonstationary
- incompressible flow simulations on dynamically varying
- spatial meshes</strong>
- <br>
- International Journal for Numerical Methods in Fluids,
- vol. 69, pp. 1045-1064, 2012.
- </li>
-
- <li> L. Blank, L. Sarbu, M. Stoll
- <br>
- <strong>Preconditioning for Allen-Cahn variational
- inequalities with non-local constraints</strong>
- <br>
- Journal of Computational Physics, vol. 231, pp. 5406-5402, 2012.
- </li>
-
- <li> C. Boehm, M. Ulbrich
- <br>
- <strong>A Newton-CG method for full-waveform inversion in a
- coupled solid-fluid system</strong>
- <br>
- submitted, 2012.
- <!-- http://www-m1.ma.tum.de/bin/view/Lehrstuhl/PublikationenUlbrich -->
- </li>
-
- <li>
- M. Braack, G. Lube, L. Röhe
- <br>
- <strong>Divergence preserving interpolation on anisotropic
- quadrilateral meshes
- </strong>
- <br>
- Comput. Methods Appl. Math., Vol. 12, pp. 123-138, 2012.
- </li>
-
- <li> <a href="http://www.math.kit.edu/ianm2/~buerg/"
- target="_top">M. Bürg</a>
- <br>
- <strong>A Residual-Based A Posteriori Error Estimator for the
- <it>hp</it>-Finite Element Method for Maxwell's Equations
- </strong>
- <br>
- Appl. Numer. Math., vol. 62, pp. 922-940, 2012.
- </li>
-
- <li> <a href="http://www.math.kit.edu/ianm2/~buerg/"
- target="_top">M. Bürg</a>
- <br>
- <strong>Convergence of an automatic
- <it>hp</it>-adaptive finite element strategy for Maxwell's equations
- </strong>
- <br>
- Preprint 12/04, Karlsruhe Institute of Technology (KIT), 2012.
- </li>
-
- <li> <a href="http://www.math.kit.edu/ianm2/~buerg/"
- target="_top">M. Bürg</a>
- <br>
- <strong>A Fully Automatic <it>hp</it>-Adaptive Refinement Strategy
- </strong>
- <br>
- PhD Thesis, Karlsruhe Institute of Technology (KIT), 2012.
- </li>
-
- <li> A. Cangiani, J. Chapman, E. Georgoulis, M. Jensen
- <br>
- <strong>On Local Super-Penalization of Interior Penalty Discontinuous Galerkin Methods</strong>
- <br>
- arXiv:1205.5672v1 [math.NA], 2012.
- <!-- http://www2.le.ac.uk/departments/mathematics/extranet/staff-material/staff-profiles/eg64/publications -->
- <!-- http://arxiv.org/abs/1205.5672 -->
- </li>
-
- <li> A. Cangiani, E. Georgoulis, S. Metcalfe
- <br>
- <strong>An a posteriori error estimator for discontinuous
- Galerkin methods for non-stationary convection-diffusion
- problems
- </strong>
- <br>
- submitted, 2012.
- <!-- http://www2.le.ac.uk/departments/mathematics/extranet/staff-material/staff-profiles/eg64/publications -->
- </li>
-
- <li> A. Cangiani, E. Georgoulis, M. Jensen
- <br>
- <strong>Discontinuous Galerkin methods for mass transfer through
- semi-permeable membranes
- </strong>
- <br>
- submitted, 2012.
- <!-- http://www2.le.ac.uk/departments/mathematics/extranet/staff-material/staff-profiles/eg64/publications -->
- </li>
-
- <li> T. Carraro, J. Joos, B. Rüger, A. Weber, E. Ivers-Tiffée
- <br>
- <strong>3D finite element model for reconstructed mixed-conducting
- cathodes: I. Performance quantification</strong>
- <br>
- Electrochimica Acta, Volume 77, pp. 315-323, 2012.
- </li>
-
- <li> T. Carraro, J. Joos, B. Rüger, A. Weber, E. Ivers-Tiffée
- <br>
- <strong>3D finite element model for reconstructed mixed-conducting
- cathodes: II. Parameter sensitivity analysis</strong>
- <br>
- Electrochimica Acta, Volume 77, pp. 309-314, 2012.
- </li>
-
- <li> A. Demlow, A. H. Georgoulis
- <br>
- <strong>Pointwise a posteriori error control for
- discontinuous Galerkin methods for elliptic problems</strong>
- <br>
- SIAM Journal on Numerical Analysis, vol. 50, pp. 2159-2181, 2012.
- </li>
-
- <li> P. Dobson, C. Lei, T. Navessin, M. Secanell
- <br>
- <strong>Characterization of the PEM Fuel Cell Catalyst Layer
- Microstructure by Nonlinear Least-Squares Parameter
- Estimation</strong>
- <br>
- Journal of the Electrochemical Society, 159(5), B1-B10, 2012.
- </li>
-
- <li> Y. Efendiev, J. Galvis, R. Lazarov, J. Willems
- <br>
- <strong>Robust domain decomposition preconditioners for abstract
- symmetric positive definite bilinear forms
- </strong>
- <br>
- ESAIM: Mathematical Modelling and Numerical Analysis, vol. 46,
- pp. 1175-1199, 2012.
- </li>
-
- <li> Y. Efendiev, J. Galvis, R. Lazarov, J. Willems
- <br>
- <strong> Robust solvers for symmetric positive definite operators
- and weighted Poincaré inequalities
- </strong>
- <br>
- In I. Lirkov, S. Margenov, and J. Wasniewski, editors, Large-Scale
- Scientific Computing: 8th International Conference, LSSC 2011,
- Sozopol, Bulgaria, 43-51, Lecture Notes in Computer Science,
- Springer, 2012.
- </li>
-
- <li> J. Fang, X. Gao, A. Zhou
- <br>
- <strong>A Kohn-Sham equation solver based on hexahedral finite elements</strong>
- <br>
- Journal of Computational Physics, vol. 231, pp. 3166–3180, 2012.
- </li>
-
- <li> T. Fankhauser
- <br>
- <strong>An hp-adaptive strategy based on smoothness
- estimation in 2d
- </strong>
- <br>
- Master Thesis, University of Bern, Switzerland, 2012.
- </li>
-
- <li> T. Fankhauser, T. P. Wihler, M. Wirz
- <br>
- <strong>hp-adaptive FEM based on continuous Sobolev
- embeddings: isotropic refinements
- </strong>
- <br>
- Research report 2012-10, University of Bern, Switzerland, 2012.
- </li>
-
- <li> L. Ferguson
- <br>
- <strong>Brittle fracture modeling with a surface tension
- excess property
- </strong>
- <br>
- PhD thesis, Texas A&M University, 2012.
- </li>
-
- <li> A. Frisani, Y. Hassan
- <br>
- <strong>A Projection Approach for the Immersed Finite Element Method
- </strong>
- <br>
- Transactions of the American Nuclear Society, vol. 106, 2012.
- </li>
-
- <li> J. J. Gaitero, J. S. Dolado, C. Neuen, F. Heber, E. Koenders
- <br>
- <strong>Computational 3d simulation of Calcium leaching in
- cement matrices
- </strong>
- <br>
- Institut für numerische Simulation, Rheinische
- Friedrich-Wilhelms-Universität Bonn, INS Preprint 1203, 2012.
- </li>
-
- <li> T. George, A. Gupta, V. Sarin
- <br>
- <strong>An empirical analysis of the performance of iterative
- solvers for SPD systems
- </strong>
- <br>
- Submitted to ACM Trans. Math. Softw., 2011.
- </li>
-
- <li> C. Goll, T. Wick, W. Wollner
- <br>
- <strong>DOpElib: Differential Equations and Optimization Environment;
-A Goal Oriented Software Library for Solving PDEs and Optimization Problems with PDEs
- </strong>
- <br>
- submitted in Dec 2012.
- </li>
-
- <li> N. Gupta, N. Nataraj
- <br>
- <strong>A posteriori error estimates for an optimal control
- problem of laser surface hardening of steel
- </strong>
- <br>
- Adv. Comp. Math., published online, 2011.
- <!-- http://www.springerlink.com/content/q25382q384582667/ -->
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Higher-order and adaptive discontinuous Galerkin
- methods with shock-capturing applied to transonic turbulent
- delta wing flow
- </strong>
- <br>
- 50<sup>th</sup> AIAA Aerospace Sciences Meeting, AIAA 2012-459, 2012.
- </li>
-
- <li>
- S. Kramer
- <br>
- <strong>Finite-element methods for spatially resolved mesoscopic
- electron transport
- </strong>
- <br>
- Phys. Rev. B 88, p. 125308, 2013
- <br>
- <a href="http://link.aps.org/doi/10.1103/PhysRevB.88.125308">DOI:
- 10.1103/PhysRevB.88.125308</a>
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Higher-order and adaptive Discontinuous Galerkin
- methods applied to turbulent delta wing flow </strong>
- <br>
- In H. P. Kreplin, editor, New Results in Numerical and
- Experimental Fluid Mechanics VIII: Contributions to the 17th
- STAB/DGLR Symposium Berlin, Germany, 2010, Notes on
- Numerical Fluid Mechanics and Multidisciplinary Design,
- Springer. In press.
- </li>
-
- <li> L. Heltai, S. Roy, F. Costanzo
- <br>
- <strong>A Fully Coupled Immersed Finite Element Method for
- Fluid Structure Interaction via the Deal.II Library</strong>
- <br>
- arXiv:1209.2811 [math.NA], 2012.
- </li>
-
- <li>
- M. Hintermüller, A. Schiela, W. Wollner
- <br>
- <strong>The length of the primal-dual path in
- Moreau-Yosida-based path-following for state constrained
- optimal control
- </strong>
- <br>
- IGB-Report 57, Karl-Franzens-University Graz, Austria, 2012.
- </li>
-
- <li> M. Hinze, M. Kunkel, A. Steinbrecher, T. Stykel
- <br>
- <strong>Model order reduction of coupled circuit-device systems
- </strong>
- <br>
- International Journal of Numerical Modelling: Electronic
- Networks, Devices and Fields,
- vol. 25, pp. 362-377, 2012.
- </li>
-
- <li> O. Jirousek, P. Zlamal
- <br>
- <strong>Large-scale micro-finite element simulation of
- compressive behavior of trabecular bone microstructure</strong>
- <br>
- Proceedings of the 18th Conference on Engineering Mechanics,
- Svratka, Czech Republic, May 14-17, 2012; paper #206,
- pp. 543-549, 2012.
- </li>
-
- <li> J. Joos, M. Ender, T. Carraro, A. Weber, E. Ivers-Tiffée
- <br>
- <strong>Representative Volume Element Size for Accurate Solid Oxide
- Fuel Cell Cathode Reconstructions from Focused Ion Beam Tomography
- Data</strong>
- <br>
- Electrochimica Acta, in press, 2012.
- <!-- http://www.sciencedirect.com/science/article/pii/S001346861200761X -->
- </li>
-
- <li> S. Joshi
- <br>
- <strong>A model for the estimation of residual stresses in
- soft tissues
- </strong>
- <br>
- Ph.D. thesis, Texas A&M University, 2012.
- </li>
-
- <li> M. Kronbichler, T. Heister, W. Bangerth
- <br>
- <strong>High Accuracy Mantle Convection Simulation through Modern
- Numerical Methods
- </strong>
- <br>
- Geophysical Journal International, vol. 191, pp. 12-29, 2012.
- </li>
-
- <li> K. Kormann
- <br>
- <strong>A time-space adaptive method for the
- Schrödinger equation
- </strong>
- <br>
- University of Uppsala, research report, 2012.
- </li>
-
- <li> M. Kunkel
- <br>
- <strong>Nonsmooth Newton Methods and Convergence of
- Discretized Optimal Control Problems subject to DAEs
- </strong>
- <br>
- PhD thesis, Universität der Bundeswehr München, 2012.
- </li>
-
- <li> A. T. McBride, J. Mergheim, A. Javili, P. Steinmann, S. Bargmann
- <br>
- <strong>Micro-to-macro transitions for heterogeneous material
- layers accounting for in-plane stretch
- </strong>
- <br>
- Journal of the Mechanics and Physics of Solids, vol. 60, pp. 1221-1239, 2012.
- </li>
-
- <li> C. Neuen, M. Griebel, J. Hamaekers
- <br>
- <strong>Multiscale simulation of ion migration for battery system
- </strong>
- <br>
- Institut für numerische Simulation, Rheinische
- Friedrich-Wilhelms-Universität Bonn, INS Preprint 1208, 2012.
- </li>
-
- <li> M. J. Rapson, J. C. Tapson, D. Karpul
- <br>
- <strong>Unification and Extension of Monolithic State Space
- and Iterative Cochlear Models
- </strong>
- <br>
- Journal of the Acoustical Society of America, vol. 131, pp. 3935-3952, 2012.
- </li>
-
- <li> N. Richardson
- <br>
- <strong>An Investigation into Aspects of Rate-Independent Single Crystal Plasticity
- </strong>
- <br>
- Master's thesis, University of Cape Town, South Africa, 2012.
- </li>
-
- <li> D. Riedlbauer, J. Mergheim, A. McBride, P. Steinmann
- <br>
- <strong>Macroscopic modelling of the selective beam melting process
- </strong>
- <br>
- PAMM, vol. 12, p. 381-382, 2012.
- </li>
-
- <li> E. Romero Alcalde
- <br>
- <strong>Parallel implementation of Davidson-type methods for large-scale eigenvalue problems
- </strong>
- <br>
- PhD thesis,
- Universitat Politecnica de Valencia, 2012.
- </li>
-
- <li> S. Roy
- <br>
- <strong>Numerical simulation using the generalized immersed boundary
- method: An application to Hydrocephalus
- </strong>
- <br>
- PhD thesis, The Pennsylvania State University, 2012.
- </li>
-
- <li> J.-P. V. Pelteret, B. D. Reddy
- <br>
- <strong>Computational model of soft tissues in the human upper airway
- </strong>
- <br>
- International Journal for Numerical Methods in Biomedical Engineering,
- Vol. 28, pp. 111–132, 2012.
- </li>
-
- <li> D. Schötzau, C. Schwab, T. Wihler, M. Wirz
- <br>
- <strong>Exponential convergence of the hp-DGFEM for elliptic
- problems in polyhedral domains
- </strong>
- <br>
- Research Report 2012-40, Seminar für Angewandte
- Mathematik, ETH Zurich, 2012.
- </li>
-
- <li> J. Sheldon
- <br>
- <strong>A comparison of fluid-structure interaction coupling
- algorithms using the finite element method
- </strong>
- <br>
- MSc thesis, The Pennsylvania State University, 2012.
- </li>
-
- <li>
- M. Stoll, A. Wathen
- <br>
- <strong>Preconditioning for partial differential equation
- constrained optimization with control constraints
- </strong>
- <br>
- Numerical Linear Algebra with Applications, vol. 19, pp. 53-71,
- 2012.
- </li>
-
- <li> M. Stoll, A. Wathen
- <br>
- <strong>All-at-once solution of time-dependent PDE-constrained optimization problems
- </strong>
- <br>
- Preprint, University of Magdeburg, 2012
- <!-- http://www.mpi-magdeburg.mpg.de/people/stollm/pub.html -->
- </li>
-
- <li> M. Stoll, A. Wathen
- <br>
- <strong>All-at-once solution of time-dependent Stokes control
- </strong>
- <br>
- Journal of Computational Physics, vol. 232, pp. 498-515, 2012.
- </li>
-
- <li> W. Symes, X. Wang
- <br>
- <strong>Harmonic coordinate finite element method for acoustic waves
- </strong>
- <br>
- SEG Technical Program Expanded Abstracts 2012, pp. 1-5, 2012.
- </li>
-
- <li> S. Taylor, K. Dontsova, S. Bigl, C. Richardson, J. Lever,
- J. Pitt, J. P. Bradley, M. Walsh. J. Simunek
- <br>
- <strong>Dissolution Rate of Propellant Energetics from Nitrocellulose Matrices
- </strong>
- <br>
- Engineer Research and Development Center, Cold Regions
- Research and Engineering Laboratory, US Army Corps of
- Engineers,
- Technical Report ER-1691, 2012.
- </li>
-
- <li> M. Thalhammer, J. Abhau
- <br>
- <strong>A numerical study of adaptive space and time discretisations for Gross–Pitaevskii equations
- </strong>
- <br>
- Journal of Computational Physics, vol. 231, pp. 6665-6681, 2012.
- </li>
-
- <li> J. Trangenstein
- <br>
- <strong>Numerical Solution of Elliptic and Parabolic Partial
- Differential Equations
- </strong>
- <br>
- Cambridge University Press, 2012.
- </li>
-
- <li> M. Vavalis, M. Mu, G. Sarailidis
- <br>
- <strong>Finite element simulations of window Josephson junctions
- </strong>
- <br>
- Journal of Computational and Applied Mathematics, vol. 236,
- pp. 3186-3197, 2012.
- </li>
-
- <li> M. Wallraff, T. Leicht, M. Lange-Hegermann
- <br>
- <strong>Numerical flux functions for Reynolds-averaged Navier-Stokes
- and kω turbulence model computations with a line-preconditioned
- p-multigrid discontinuous Galerkin solver</strong>
- <br>
- Int. J. Numer. Meth. Fluids, published online, 2012.
- <!-- http://onlinelibrary.wiley.com/doi/10.1002/fld.3702/full -->
- </li>
-
- <li> M. Wallraff, T. Leicht, M. Lange-Hegermann
- <br>
- <strong>Numerical flux functions for RANS-kω computations with a
- line-implicit p-multigrid DG solver</strong>
- <br>
- 50<sup>th</sup> AIAA Aerospace Sciences Meeting, AIAA 2012-458, 2012.
- </li>
-
-
- <li> T. Wick
- <br>
- <strong>Goal-oriented mesh adaptivity for fluid-structure interaction with application to heart-valve settings
- </strong>
- <br>
- Arch. Mech. Engrg., vol. 59, pp. 73-99, 2012.
- </li>
-
-
-
- <li> J. Willems
- <br>
- <strong>Robust multilevel methods for general symmetric positive
- definite operators
- </strong>
- <br>
- RICAM Report 2012-06, 2012.
- </li>
-
- <li> S. Yoon, M. A. Walkley, O. G. Harlen
- <br>
- <strong>Two particle interactions in a confined viscoelastic fluid under shear
- </strong>
- <br>
- Journal of Non-Newtonian Fluid Mechanics, vol. 185/186, pp. 39-48, 2012.
- </li>
-
- <li> S. Zhang, X. Lin, H. Zhang, D. A. Yuen, Y. Shi
- <br>
- <strong>A new method for calculating displacements from
- elastic dislocation over arbitrary 3-D fault surface with
- extended FEM and Adaptive Mesh Refinement (AMR)</strong>
- <br>
- Proceedings of the International Workshop on Deep Geothermal
- Systems, Wuhan, China, June 29-30, 2012.
- </li>
- </ol>
-
- <a name="2011"> </a>
- <h2>Publications in 2011</h2>
-
- <!-- Please enter alphabetically by name -->
- <ol>
- <li> I. Adeniran, M. J. McPate, H. J. Wichtel, J. C. Hancox,
- H. Zhang
- <br>
- <strong>Increased vulnerability of human ventricle to
- re-entrant excitation in hERG-linked variant 1 short QT
- syndrome
- </strong>
- <br>
- PLoS Computational Biology, vol. 7, e1002313, 2011.
- </li>
-
- <li> M. Allmaras
- <br>
- <strong>Modeling aspects and computational methods for some recent
- problems of tomographic imaging
- </strong>
- <br>
- PhD thesis, Texas A&M University, 2011.
- </li>
-
- <li> M. Allmaras, W. Bangerth
- <br>
- <strong>Reconstructions in ultrasound modulated optical tomography
- </strong>
- <br>
- J. Inverse and Ill-posed Problems, vol. 19, pp. 801-823, 2011.
- </li>
-
- <li> F. Alouges, A. DeSimone, L. Heltai
- <br>
- <strong>Numerical strategies for stroke optimization of
- axisymmetric microswimmers
- </strong>
- <br>
- Mathematical Models and Methods in Applied Sciences, vol. 21, pp. 361-387, 2011.
- </li>
-
- <li> <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>,
- <a href="http://users.ices.utexas.edu/~carsten/"
- target="_top">C. Burstedde</a>, T. Heister, M. Kronbichler
- <br>
- <strong>Algorithms and Data Structures for Massively Parallel Generic
- Finite Element Codes</strong>
- <br>
- ACM Trans. Math. Softw., vol. 38, article 124, 2011.
- </li>
-
- <li> K. Benzarti, F. Freddi, M. Frémond
- <br>
- <strong>A damage model to predict the durability of bonded
- assemblies. Part I: Debonding behavior of FRP strengthened
- concrete structures</strong>
- <br>
- Construction and Building Materials, 25(2), 547-555, 2011.
- </li>
-
- <li> A. Buehler, A. Rosenthal, T. Jetzfellner, A. Dima,
- D. Razansky, V. Ntziachristos
- <br>
- <strong>Model-based optoacoustic inversions with incomplete projection
- data</strong>
- <br>
- Med. Phys., vol. 38, pp. 1694-1704, 2011.
- </li>
-
- <li> M. Bürg, W. Dörfler
- <br>
- <strong>Convergence of an adaptive hp finite element strategy in higher
- space-dimensions</strong>
- <br>
- Appl. Numer. Math. 61, pp. 1132-1146, 2011.
- </li>
-
- <li> A. Cangiani, E. Georgoulis, M. Jensen
- <br>
- <strong>Discontinuous Galerkin methods for convection-diffusion
- problems modelling mass transfer through semipermeable membranes.
- </strong>
- <br>
- Proceedings of the Congress on Numerical Methods in Engineering,
- Coimbra, 2011.
- </li>
-
- <li> P. Carrara, D. Ferretti, F. Freddi, G. Rosati
- <br>
- <strong>Shear tests of carbon fiber plates bonded to concrete with
- control of snap-back
- </strong>
- <br>
- Engineering Fracture Mechanics, vol. 78, pp. 2663-2678, 2011.
- </li>
-
- <li>
- S. Chandrasekaran, K. R. Jayaraman, M. Gu, H. N. Mhaskar, J. Moffitt
- <br>
- <strong>MSNFD: A Higher Order Finite Difference Method for Solving Elliptic
- PDEs on scattered points (An Extended version of our paper
- submitted to ICCS 2011)</strong>
- <br>
- submitted, 2011.
- <!-- http://scg.ece.ucsb.edu/msnpub.html -->
- </li>
-
- <li> B. Crestel
- <br>
- <strong>Moving meshes on general surfaces
- </strong>
- <br>
- Ph.D. thesis, Simon Fraser University, 2011
- </li>
-
- <li> E. Emmrich, D. Šiška
- <br>
- <strong>Full discretization of second-order nonlinear evolution
- equations: Strong convergence and applications
- </strong>
- <br>
- Preprint, University of Bielefeld, 2011.
- </li>
-
- <li> F. Freddi, G. Royer-Carfagni
- <br>
- <strong>Variational fracture mechanics for
- compressive splitting of masonry-like materials
- </strong>
- <br>
- Annals of Solid and Structural Mechanics, vol. 2, pp. 57-67, 2011.
- </li>
-
- <li> M. Freyer
- <br>
- <strong>Automatische Segmentierung anatomischer Strukturen in
- CT-Bildern eines hybriden FMT/XCT-Systems zur Verbesserung der
- optischen Bildgebung
- </strong>
- <br>
- Ph.D. thesis, Ludwig-Maximilians-University Munich, Germany, 2011.
- </li>
-
- <li> J. Frohne
- <br>
- <strong>FEM-Simulation der Umformtechnik metallischer
- Oberflächen im Mikrokosmos
- </strong>
- <br>
- Ph.D. thesis, University of Siegen, Germany, 2011.
- </li>
-
- <li>
- S. Gladkov, T. Kayser, B. Svendsen
- <br>
- <strong>FE-modeling of ideal grain growth based on
- preprocessed EBSD data
- </strong>
- <br>
- PAMM, vol. 11, pp.471-472 2011.
- </li>
-
- <li> A. Ginzburg
- <br>
- <strong>Introduction to Geophysics (in Hebrew)
- </strong>
- <br>
- The Open University of Israel, 2011.
- </li>
-
- <li> J.-L. Guermond, A. Salgado
- <br>
- <strong>Error analysis of a fractional time-stepping technique for
- incompressible
- flows with variable density.
- </strong>
- <br>
- SIAM J. of Numerical Analysis, vol. 49, pp. 917-944, 2011.
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>, J. Held, T. Leicht
- <br>
- <strong>Adjoint-based error estimation and adaptive mesh refinement
- for the RANS and k-ω turbulence model equations
- </strong>
- <br>
- J. Comput. Phys., vol. 230, pp. 4268-4284, 2011.
- </li>
-
- <li> T. Heister
- <br>
- <strong>A Massively Parallel Finite Element Framework with
- Application to Incompressible Flows</strong>
- <br>
- Ph.D. thesis, University of Göttingen, Germany, 2011
- </li>
-
- <li> L. Heltai, F. Costanzo
- <br>
- <strong>Variational implementation of immersed finite
- element methods
- </strong>
- <br>
- Computer Methods in Applied Mechanics and Engineering,
- vol. 229–232, pp. 110–127, 2012.
- </li>
-
- <li> M. Hinze, M. Kunkel, M. Vierling
- <br>
- <strong>POD model order reduction of drift-diffusion equations in electrical networks
- </strong>
- <br>
- in: Model Reduction for Circuit Simulation, P. Benner,
- M. Hinze, and J. ter Maten (eds.), Lecture Notes in
- Electrical Engineering, vol. 74, Berlin-Heidelberg:
- Springer-Verlag, p. 177–192, 2011.
- </li>
-
- <li> M. Hinze, M. Kunkel, U. Matthes, M. Vierling
- <br>
- <strong>Model order reduction of integrated circuits in
- electrical networks</strong>
- <br>
- Hamburger Beiträge zur Angewandten Mathematik, Nr. 2011-14.
- </li>
-
- <li> M. Hinze, M. Kunkel, A. Steinbrecher, T. Stykel
- <br>
- <strong>Model order reduction of coupled circuit-device systems</strong>
- <br>
- Hamburger Beiträge zur Angewandten Mathematik, Nr. 2011-08.
- </li>
-
- <li> O. P. Iliev, R. D. Lazarov, J. Willems
- <br>
- <strong>Variational multiscale finite element method for flows in
- highly porous media</strong>
- <br>
- SIAM Multiscale Modeling and Simulation, submitted, 2011
- </li>
-
- <li> <a
- href="http://numerik.uni-hd.de/~baer"
- target="_top">B. Janssen</a>, G. Kanschat
- <br>
- <strong>Adaptive multilevel methods with local smoothing</strong>
- <br>
- submitted, 2010.
- </li>
-
- <li> G. Jegert, A. Kersch, W. Weinreich, P. Lugli
- <br>
- <strong>Monte Carlo Simulation of Leakage Currents in
- TiN/ZrO<sub>2</sub>/TiN Capacitors</strong>
- <br>
- IEEE Transactions on Electron Devices, vol. 58, pp. 327-334, 2011.
- </li>
-
- <li> N. Johansson
- <br>
- <strong> Implementation of a standard level set method for
- incompressible two-phase flow simulations</strong>
- <br>
- Master's thesis, Uppsala University, Uppsala, Sweden, 2011.
- </li>
-
-
- <li> J. Joos, T. Carraro, M. Ender, B. Rüger, A. Weber, E. Ivers-Tiffée
- <br>
- <strong>Detailed Microstructure Analysis and 3D Simulations of Porous Electrodes</strong>
- <br>
- ECS Trans. 35, pp. 2357-2368, 2011.
- </li>
-
- <li> F. Keller, H. Nirschl, W. Dörfler
- <br>
- <strong>Primary charge effects on prolate spheroids with moderate aspect ratios
- </strong>
- <br>
- Journal of Colloid and Interface Science, vol. 363, pp. 690-702, 2011.
- </li>
-
- <li> K. Kormann, M. Kronbichler
- <br>
- <strong>Parallel finite element operator application: Graph
- partitioning and coloring</strong>
- <br>
- In proceedings of the 2011 IEEE 7th international conference
- on e-Science, pp. 332-339, 2011.
- </li>
-
- <li> M. Kronbichler
- <br>
- <strong>Computational Techniques for Coupled Flow-Transport Problems
- </strong>
- <br>
- PhD Thesis, Uppsala University, Uppsala, Sweden, 2011.
- </li>
-
- <li> M. Kronbichler, C. Walker, G. Kreiss, B. Müller
- <br>
- <strong>Multiscale modeling of capillary-driven contact
- line dynamics
- </strong>
- <br>
- submitted, 2011.
- </li>
-
- <li>
- W. Layton, L. Röhe, H. Tran
- <br>
- <strong>Explicitly uncoupled VMS stabilization of fluid flow
- </strong>
- <br>
- Computer Methods in Applied Mechanics and Engineering,
- vol. 200, pp. 3183-3199, 2011.
- </li>
-
- <li> T. Leicht, <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Error estimation and hp-adaptive mesh refinement for
- discontinuous Galerkin methods
- </strong>
- <br>
- In Z. J. Wang, editor, Adaptive High-Order Methods in
- Computational Fluid Dynamics - with applications in aerospace
- engineering, World Science Books, pp. 67-94, 2011.
- </li>
-
- <li> T. Leicht, <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Goal-oriented error estimation and hp-adaptive mesh
- refinement for aerodynamic flows.
- </strong>
- <br>
- 49<sup>th</sup> AIAA Aerospace Sciences Meeting AIAA 2011-212, 2011.
- </li>
-
- <li>
- K. Leonard
- <br>
- <strong>Multiphase Modelling of Tissue Engineering
- </strong>
- <br>
- Proceedings of the University of Oxford Department of
- Computer Science Student Conference 2011, pp. 18-19, 2011.
- </li>
-
- <li>
- J. Löwe, G. Lube, L. Röhe
- <br>
- <strong>A Projection-Based Variational Multiscale Method for
- the Incompressible Navier–Stokes/Fourier Model
- </strong>
- <br>
- BAIL 2010 - Boundary and Interior Layers, Computational and
- Asymptitic Methods. Lecture Notes in Computational Science
- and Engineering, Volume 81, pp. 165-175, 2011.
- </li>
-
- <li> C. E. Michoski, J. A. Evans, P. G. Schmitz
- <br>
- <strong>Modeling Chemical Reactors I: Quiescent Reactors
- </strong>
- <br>
- Preprint, arXiv, 2010
- </li>
-
- <li> M. T. Myers, B. H. Sencer, L. Shao
- <br>
- <strong>Multi-scale modeling of localized heating caused by ion bombardment
- </strong>
- <br>
- Nuclear Instruments and Methods in Physics Research Section
- B: Beam Interactions with Materials and Atoms, in press,
- 2011.
- <!-- http://www.sciencedirect.com/science/article/pii/S0168583X11000760 -->
- </li>
-
- <li> A. Nigro, S. Renda, C. De
- Bartolo, <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>, F. Bassi
- <br>
- <strong>A discontinuous Galerkin method for laminar low Mach number flows
- </strong>
- <br>
- 66th National Congress ATI in Rende, Italy, 5-9
- Sept. 2011. University of Calabria, 2011.
- </li>
-
- <li> R. H. Nochetto, A. Salgado, S. W. Walker
- <br>
- <strong>A diffuse interface model for electrowetting
- with moving contact lines
- </strong>
- <br>
- Arxiv preprint arXiv:1112.5758. Submitted to M3AS, 2011.
- </li>
-
- <li>
- J. A. Norato, A. J. Wagoner Johnson
- <br>
- <strong>A Computational and Cellular Solids Approach to the
- Stiffness-Based Design of Bone Scaffolds
- </strong>
- <br>
- J. Biomech. Eng., vol. 133, 091003/1-8, 2011.
- </li>
-
- <li>
- J. Pearson, M. Stoll, A. Wathen
- <br>
- <strong>Regularization-robust preconditioners for
- time-dependent PDE constrained optimization problems
- </strong>
- <br>
- Preprint 1398, The Mathematical Institute, University of Oxford,
- submitted to SIAM, 2011.
- <!-- http://eprints.maths.ox.ac.uk/1398/ -->
- </li>
-
- <li> D. Pilipenko, M. Fleck, H. Emmerich
- <br>
- <strong>On numerical aspects of phase field fracture modelling
- </strong>
- <br>
- European Phys. J. Plus, vol. 126, 100/1-16, 2011.
- </li>
-
- <li> K. J. Raghuram
- <br>
- <strong>Higher Order Numerical Discretization on Scattered Grids
- </strong>
- <br>
- PhD thesis, University of California, Santa Barbara, 2011.
- </li>
-
- <li> M. J. Rapson, J. C. Tapson
- <br>
- <strong>Emulating the theoretical
- bifurcation diagram of a cochlear model in computation
- </strong>
- <br>
- Second African Conference on Computational Mechanics - AfriCOMP11,
- 2011
- </li>
-
- <li> M. J. Rapson, J. C. Tapson
- <br>
- <strong>Investigations into Time
- Stepping Methods for Cochlear Models
- </strong>
- <br>
- International Journal for Numerical Methods in Biomedical Engineering,
- accepted, 2011
- </li>
-
- <li> T. Richter, T. Wick
- <br>
- <strong>Fluid-Structure Interactions in ALE and
- Fully Eulerian Coordinates
- </strong>
- <br>
- PAMM, vol. 10, pp. 487-488, 2011.
- </li>
-
- <li> D. Riedlbauer
- <br>
- <strong>Thermomechanical Modelling and Simulation of Electron Beam Melting
- </strong>
- <br>
- Master's thesis, Friedrich-Alexander-University, Erlangen-Nuremberg, 2011.
- </li>
-
- <li>
- L. Röhe, G. Lube
- <br>
- <strong> Large-Eddy Simulation of Wall-Bounded Turbulent
- Flows: Layer-Adapted Meshes vs. Weak Dirichlet Boundary
- Conditions
- </strong>
- <br>
- BAIL 2010 - Boundary and Interior Layers, Computational and
- Asymptitic Methods. Lecture Notes in Computational Science
- and Engineering, Volume 81, pp. 197-205, 2011.
- </li>
-
- <li> A. Salgado
- <br>
- <strong>A diffuse interface fractional time-stepping technique
- for incompressible two-phase flows with moving contact lines
- </strong>
- <br>
- Submitted to Comp. Meths. Appl. Mech. Engrg., 2011.
- </li>
-
- <li> A. Salgado
- <br>
- <strong>A general framework for the implementation of
- mulitphysics and multidomain problems using the deal.II
- library
- </strong>
- <br>
- Submitted to Archive of Numerical Software, 2011.
- </li>
-
- <li>
- M. Stoll, J. Pearson, A. Wathen
- <br>
- <strong>Preconditioners for state constrained optimal
- control problems with Moreau-Yosida penalty function
- </strong>
- <br>
- Submitted to Numerical Linear Algebra with Applications,
- 2011.
- <!-- http://www.mpi-magdeburg.mpg.de/mpcsc/mitarbeiter/stollm/Data/SC_NLA11.pdf -->
- <!-- http://www.mpi-magdeburg.mpg.de/people/stollm/pub.html -->
- </li>
-
- <li>
- J. White, R. I. Borja
- <br>
- <strong>Block-preconditioned Newton–Krylov solvers for fully coupled flow and geomechanics
- </strong>
- <br>
- Comp. Geosc., vol. 15, pp. 647-659, 2011.
- </li>
-
- <li> T. Wick
- <br>
- <strong>Fluid-structure interactions using different mesh motion techniques
- </strong>
- <br>
- Computers and Structures, vol. 89, pp. 1456-1467, 2011.
- </li>
-
- <li> T. Wick
- <br>
- <strong>Adaptive finite element simulation of fluid-structure
- interaction
- </strong>
- <br>
- PhD thesis, University of Heidelberg, Germany, 2011.
- </li>
-
- <li> <a href="http://www.ippt.gov.pl/~tyoung"
- target="_top">T. D. Young</a>
- <Br>
- <strong>A qualitative semi-classical treatment of an isolated
- semi-polar quantum dot
- </strong>
- <br>
- J. Phys.: Conf. Ser., 28(10), 2011.
- </li>
-
- <li> S. Zahedi, <a href="http://www.it.uu.se/katalog/martinkr"
- target="_top">M. Kronbichler</a>, G. Kreiss
- <br>
- <strong>Spurious currents in finite element based level set methods
- for two-phase flow</strong>
- <br>
- Int. J. Numer. Meth. Fluids., vol. 67, 2011.
- </li>
-
- <li> L. Zhou, B. Yazici
- <br>
- <strong>Discretization Error Analysis and Adaptive Meshing
- Algorithms for Fluorescence Diffuse Optical Tomography in the
- Presence of Measurement Noise</strong>
- <br>
- IEEE Trans. Image Processing, vol. 20, pp. 1094-1111, 2011.
- </li>
-
- <li> L. Zhu, D. Schötzau
- <br>
- <strong>A robust a posteriori error estimate for hp-adaptive DG
- methods for convection-diffusion equations
- </strong>
- <br>
- IMA J. Numer. Math., vol. 31, pp. 971-1005, 2011.
- </li>
- </ol>
-
-
-
- <a name="2010"> </a>
- <h2>Publications in 2010</h2>
-
- <!-- Please enter alphabetically by name -->
- <ol>
- <li> M. Alexe, A. Sandu
- <br>
- <strong>Space-time adaptive solution of inverse problems with the
- discrete adjoint method
- </strong>
- <br>
- Technical Report TR-10-14, Computational Science Laboratory,
- Department of Computer Science, Virginia Tech, 2010.
- </li>
-
- <li> M. S. Alnæs, K.-A. Mardal
- <br>
- <strong>On the efficiency of symbolic computations combined with code
- generation for finite element methods
- </strong>
- <br>
- ACM Transactions on Mathematical Software, vol. 37, 8/1-26, 2010.
- </li>
-
- <li> M. Arroyo, A. DeSimone, L. Heltai
- <br>
- <strong>The role of membrane viscosity in the dynamics of fluid
- membranes
- </strong>
- <br>
- arXiv:1007.4934, 2010.
- <!-- http://arxiv.org/abs/1007.4934 -->
- </li>
-
- <li> W. Bangerth, M. Geiger, R. Rannacher
- <br>
- <strong>Adaptive Galerkin finite element methods
- for the wave equation
- </strong>
- <br>
- Computational Methods in Applied Mathematics, vol. 10, pp.3-48, 2010.
- </li>
-
- <li> S. Bartle, A. McBride, B. D. Reddy
- <br>
- <strong>Shell finite elements, with applications in biomechanics</strong>
- <br>
- In: Kok, S. (Ed.): Proceedings of 7th South African Conference on
- Computational and Applied Mechanics (University of Pretoria, Pretoria,
- South Africa). 2010.
- </li>
-
- <li> A. Cangiani, R. Natalini
- <br>
- <strong>A spatial model of cellular molecular trafficking
- including active transport along microtubules</strong>
- <br>
- Journal of Theoretical Biology, vol. 267, pp. 614-625, 2010.
- </li>
-
- <li> C.-C. Chueh, M. Secanell, W. Bangerth, N. Djilali
- <br>
- <strong>Multi-level Adaptive Simulation of Transient Two-phase Flow in
- Heterogeneous Porous Media</strong>
- <br>
- Computers and Fluids, vol. 39, pp. 1585-1596, 2010.
- </li>
-
- <li> C.-C. Chueh
- <br>
- <strong>Integrated adaptive numerical methods for transient
- two-phase flow in heterogeneous porous medi</strong>
- <br>
- Ph.D. thesis, University of Victoria, 2010.
- </li>
-
- <li> T. Dally
- <br>
- <strong>FE-Modelladaptivität für P-Laplace
- </strong>
- <br>
- Master's thesis, Universität Siegen, Germany, 2010
- </li>
-
- <li> M. Freyer, A. Ale, R. Schulz, M. Zientkowska,
- V. Ntziachristos, K.-H. Englmeier
- <br>
- <strong>Fast automatic segmentation of anatomical structures
- in x-ray computed tomography images to improve fluorescence
- molecular tomography reconstruction</strong>
- <br>
- Journal of Biomedical Optics, vol. 15, pp. 036006/1-8, 2010.
- <br>
- </li>
-
- <li> F. Freddi, M. Frémond
- <br>
- <strong>Collision and Fractures: a predictive theory
- </strong>
- <br>
- European Journal of Mechanics - A/Solids, vol. 29, pp. 998-1007, 2010.
- </li>
-
- <li> F. Freddi, G. Royer-Carfagni
- <br>
- <strong>Regularized Variational Theories of Fracture: a
- Unified Approach</strong>
- <br>
- Journal of the Mechanics and Physics of Solids, vol. 58,
- pp. 1154-1174, 2010.
- </li>
-
- <li> P. Ghysels, G. Samaey, P. Van Liedekerke, E. Tijskens,
- H. Ramon, D. Roose
- <br>
- <strong>Multiscale modeling of viscoelastic plant tissue
- </strong>
- <br>
- Int. J. Multisc. Comput. Engrg., vol. 8, pp. 379-396, 2010
- </li>
-
- <li> P. Ghysels, G. Samaey, P. Van Liedekerke, E. Tijskens,
- H. Ramon, D. Roose
- <br>
- <strong>Coarse implicit time integration of a cellular scale particle
- model for plant tissue deformation
- </strong>
- <br>
- Int. J. Multisc. Comput. Engrg., vol. 8, pp. 411-422, 2010
- </li>
-
- <li> V. Girault, F. Murat, A. Salgado
- <br>
- <strong>Finite element discretization of Darcy's equations with
- pressure dependent porosity.
- </strong>
- <br>
- M2AN, vol. 44, pp. 1155-1191, 2010
- </li>
-
- <li> M. Guven, L. Reilly-Raska, L. Zhou, B. Yazici
- <br>
- <strong>Discretization Error Analysis and Adaptive Meshing
- Algorithms for Fluorescence Diffuse Optical Tomography: Part
- I</strong>
- <br>
- IEEE Trans. Medical Imaging, vol. 29, pp. 217-229, 2010
- </li>
-
- <li> M. Guven, L. Zhou, L. Reilly-Raska, B. Yazici
- <br>
- <strong>Discretization Error Analysis and Adaptive Meshing
- Algorithms for Fluorescence Diffuse Optical Tomography: Part
- II</strong>
- <br>
- IEEE Trans. Medical Imaging, vol. 29, pp. 230-245, 2010
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>, J. Held, T. Leicht, F. Prill
- <br>
- <strong>Discontinuous Galerkin methods for computational aerodynamics
- — 3D adaptive flow simulation with the DLR PADGE code
- </strong>
- <br>
- Aerospace Science and Technology, vol. 14, pp. 512-529, 2010.
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>, J. Held, T. Leicht, F. Prill
- <br>
- <strong>Error estimation and adaptive mesh refinement for aerodynamic flows
- </strong>
- <br>
- 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,
- <br>
- vol. 113 of Notes on numerical fluid mechanics and
- multidisciplinary design, pp. 339-353, Springer, 2010.
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>, P. Houston
- <br>
- <strong>Error estimation and adaptive mesh refinement for aerodynamic flows</strong>
- <br>
- In H. Deconinck, editor,
- VKI LS 2010-01: 36th CFD/ADIGMA course on hp-adaptive and
- hp-multigrid methods, Oct. 26-30, 2009.
- <br>
- Von Karman Institute for Fluid Dynamics, Rhode Saint Genese,
- Belgium, 2010.
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>, T. Leicht
- <br>
- <strong>Discontinuous Galerkin Verfahren in der Aerodynamik:
- Höhere Ordnung, Fehlerschätzung und Gitteradaption
- </strong>
- <br>
- STAB Mitteilungen. 17. DGLR-Fach-Symposium der STAB, 9.-10. Nov. 2010, Berlin, 2010.
- </li>
-
- <li> T. Heister, G. Lube, G. Rapin
- <br>
- <strong>On robust parallel preconditioning for incompressible
- flow problems</strong>
- <br>
- In Numerical Mathematics and Advanced Applications, ENUMATH 2009.
- Springer, Berlin, 2010.
- </li>
-
- <li> T. Heister, M. Kronbichler, W. Bangerth
- <br>
- <strong>Generic Finite Element programming for massively parallel
- flow simulations</strong>
- <br>
- Eccomas CFD 2010 proceedings, 2010.
- </li>
-
- <li> T. Heister, M. Kronbichler, W. Bangerth
- <br>
- <strong>Massively Parallel Finite Element Programming</strong>
- <br>
- Recent Advances in the Message Passing Interface,
- Lecture Notes in Computer Science, vol. 6305/2010, pp. 122-131,
- 2010.
- </li>
-
- <li> M. Hinze, M. Kunkel
- <br>
- <strong>Discrete empirical interpolation in POD Model Order
- Reduction of Drift-Diffusion Equations in Electrical
- Networks</strong>
- <br>
- Scientific Computing in Electrical Engineering, SCEE 2010
- Mathematics in Industry, Volume 16, Part 5, 423-431, 2012.
- </li>
-
- <li> M. Hinze, M. Kunkel
- <br>
- <strong>Residual Based Sampling in POD Model Order Reduction
- of Drift-Diffusion Equations in Parametrized Electrical
- Networks</strong>
- <br>
- arXiv:1003.0551v1 [math.NA], 2010.
- </li>
-
- <li> O. P. Iliev, R. D. Lazarov, J. Willems
- <br>
- <strong>Discontinuous Galerkin Subgrid Finite Element Method for
- Heterogeneous Brinkman Equations</strong>
- <br>
- Large-Scale Scientific Computing, Lectures Notes in Computer Science,
- vol. 5910, pp. 14-25, 2010
- </li>
-
- <li> O. P. Iliev, R. D. Lazarov, J. Willems
- <br>
- <strong>Fast numerical upscaling of heat equation for fibrous
- materials</strong>
- <br>
- J. Computing and Visualization in Science, vol. 13, pp. 275-285, 2010
- </li>
-
- <li> <a
- href="http://numerik.uni-hd.de/~baer"
- target="_top">B. Janssen</a>,
- <a
- href="http://numerik.uni-hd.de/~twick"
- target="_top">T. Wick</a>
- <br>
- <strong>Block preconditioning with Schur complements
- for monolithic fluid-structure interactions</strong>
- <br>
- Proceedings of the Eccomas CFD 2010 conference,
- J. C. F. Pereira and A. Sequeira (eds.), 2010.
- </li>
-
- <li> J. Joos, B. Rüger, T. Carraro, A. Weber, E. Ivers-Tiffée
- <br>
- <strong>Electrode Reconstruction by FIB/SEM and Microstructure
- Modeling</strong>
- <br>
- ECS Trans. 28, pp. 81-91, 2010.
- </li>
-
- <li> G. Kanschat, B. Rivière
- <br>
- <strong>A strongly conservative finite element method for the coupling
- of Stokes and Darcy flow
- </strong>
- <br>
- J. Computational Physics, vol. 229, pp. 5933-5943, 2010
- </li>
-
- <li> F. Keller, M. Feist, H. Nirschl, W. Dörfler
- <br>
- <strong>Investigation of the nonlinear effects during the
- sedimentation process of a charged colloidal particle by
- direct numerical simulation
- </strong>
- <br>
- Journal of Colloid and Interface Science, vol. 344, pp. 228-236, 2010.
- </li>
-
- <li> S. Kim, J. E. Pasciak
- <br>
- <strong>Analysis of a Cartesian PML approximation to acoustic
- scattering problems in R<sup>2</sup></strong>
- <br>
- J. Math. Anal. Appl., vol. 370, pp. 168-186, 2010
- </li>
-
- <li>
- R. King, V. Mehrmann, W. Nitsche
- <br>
- <strong>Active Flow Control—A Mathematical Challenge</strong>
- <br>
- Production Factor Mathematics, Part 1, pp. 73-80, 2010
- </li>
-
- <li>
- R. King, V. Mehrmann, W. Nitsche
- <br>
- <strong>Aktive Strömungsbeeinflussung — Eine
- Mathematische Herausforderung</strong>
- <br>
- Produktionsfaktor Mathematik, Part 2, pp. 99-109, 2010
- </li>
-
- <li>
- T. Leicht, <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Error estimation and anisotropic mesh refinement for
- 3d laminar aerodynamic flow simulations
- </strong>
- <br>
- J. Comput. Phys., vol. 229, pp. 7344-7360, 2010.
- </li>
-
- <li>
- T. Leicht, <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Error estimation and anisotropic mesh refinement for
- aerodynamic flow simulations
- </strong>
- <br>
- In Numerical Mathematics and Advanced Applications, ENUMATH
- 2009, pp. 579-587. Springer, Berlin, 2010.
- </li>
-
- <li>
- G. Lube, B. Tews
- <br>
- <strong>Optimal control of singularly perturbed
- advection-diffusion-reaction problems</strong>
- <br>
- Math. Model. Meths. Appl. Sc., Vol. 20, No. 3, 375-395, 2010.
- (<a href="http://dx.doi.org/10.1142/S0218202510004271">DOI</a>)<br>
- Preprint 2008-15, Institute for Numerical and Applied
- Mathematics, University of Göttingen, Germany, 2008
- </li>
-
- <li> C. P. T. Neuen
- <br>
- <strong>A multiscale approach to the Poisson-Nernst-Planck equation
- </strong>
- <br>
- Diploma Thesis, University of Bonn, Germany, 2010
- </li>
-
- <li>
- A. Nigro, C. De Bartolo, <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>, F. Bassi
- <br>
- <strong>Discontinuous Galerkin solution of preconditioned Euler equations for very low Mach number flows
- </strong>
- <br>
- Int. J. Numer. Meth. Fluids, vol. 63, no. 4, pp. 449-467, 2010.
- </li>
-
- <li>
- F. Prill
- <br>
- <strong>Diskontinuierliche Galerkin-Methoden und schnelle iterative
- Löser zur Simulation kompressibler Strömungen
- </strong>
- <br>
- PhD thesis, TU Hamburg-Harburg, 2010. (in German)
- <br>
- Also available as DLR-FB 2010-17, DLR, 2010. ISSN 1434-8454.
- </li>
-
- <li> M. J. Rapson, J. C. Tapson
- <br>
- <strong>Capturing low‐frequency
- cochlear impedance in time domain models: The role of viscosity
- </strong>
- <br>
- J. Acoust. Soc. Am. Volume 127, Issue 3, pp. 1869-1869, 2010.
- </li>
-
- <li> K. Rupp
- <br>
- <strong>Symbolic integration at compile time in finite element methods
- </strong>
- <br>
- Proceedings of the 2010 International Symposium on Symbolic
- and Algebraic Computation, 347-354, 2010.
- </li>
-
- <li>
- T. Rees, M. Stoll, A. Wathen
- <br>
- <strong>All-at-once preconditioning in PDE-constrained
- optimization
- </strong>
- <br>
- Kybernetica, vol. 46, pp. 341-360, 2010.
- </li>
-
- <li>
- T. Richter, T. Wick
- <br>
- <strong>Finite Elements for Fluid-Structure
- Interaction in ALE and Fully Eulerian Coordinates
- </strong>
- <br>
- Comput. Meth. Appl. Mech. Engrg., vol. 199, pp. 2633-2642, 2010.
- </li>
-
- <li>
- L. Röhe, G. Lube
- <br>
- <strong>Analysis of a variational multiscale method for large-eddy
- simulation and its application to homogeneous isotropic turbulence
- </strong>
- <br>
- Comput. Meth. Appl. Mech. Engrg., vol. 199, pp. 2331-2342, 2010.
- </li>
-
- <li>
- A. Salgado
- <br>
- <strong>Approximation Techniques for Incompressible Flows
- with Heterogeneous Properties</strong>
- <br>
- Ph.D. thesis, Texas A&M University, 2010.
- </li>
-
- <li> R. Schulz, A. Ale, A. Sarantopoulos, M. Freyer, E. Soehngen,
- M. Zientkowska, V. Ntziachristos
- <br>
- <strong>Hybrid System for Simultaneous Fluorescence and X-Ray
- Computed Tomography</strong>
- <br>
- IEEE Trans. Medical Imaging, vol. 29, pp. 465-473, 2010
- </li>
-
- <li> M. Secanell, R. Songprakorp, N. Djilali, A. Suleman
- <br>
- <strong>Optimization of a proton exchange membrane fuel cell
- electrode assembly
- </strong>
- <br>
- Structural and Multidisciplinary Optimization, vol. 40, pp. 563-583,
- 2010
- </li>
-
- <li>
- M. Steigemann, M. Specovius-Neugebauer, M. Fulland, H. A. Richard
- <br>
- <strong>Simulation of crack paths in functionally graded materials
- </strong>
- <br>
- Engineering Fracture Mechanics, vol. 77, pp. 2145-2157, 2010
- </li>
-
- <li>
- M. Stoll, A. Wathen
- <br>
- <strong>All-at-once preconditioning of time-dependent PDE-constrained
- optimization problems
- </strong>
- <br>
- Preprint 1017, University of Oxford, 2010.
- </li>
-
- <li>
- B. Turcksin, J. C. Ragusa, W. Bangerth
- <br>
- <strong>Goal-oriented h-adaptivity for the multigroup SP<sub>N</sub>
- equations
- </strong>
- <br>
- Nuclear Science and Engineering, vol. 165, pp. 305-319, 2010.
- </li>
-
- <li> M. Vdroljak
- <br>
- <strong>On Hashin-Shtrikman bounds for mixtures of two isotropic
- materials
- </strong>
- <br>
- Nonlinear Analysis: Real world applications, vol. 11, pp. 4597-4606, 2010
- </li>
-
- <li> C. Weiler
- <br>
- <strong>Stromfunktionsformulierung der
- Navier-Stokes-Gleichungen und Methoden der
- Druckrekonstruktion
- </strong>
- <br>
- Diploma Thesis, University of Heidelberg, Germany, 2010
- </li>
-
- <li> <a href="http://www.ippt.gov.pl/~tyoung"
- target="_top">T. D. Young</a>, R. Armiento
- <Br>
- <strong>Strategies for <i>h</i>-adaptive refinement for a
- finite element treatment of harmonic oscillator
- Schrödinger eigenproblem
- </strong>
- <br>
- Commun. Theor. Phys. (Beijing, China), vol. 53(6),
- pp. 1017-1023, 2010.
- </li>
-
- <li>
- L. Zhu
- <br>
- <strong>Robust a posteriori error estimation for discontinuous
- Galerkin methods for convection-diffusion equations
- </strong>
- <br>
- Ph.D. thesis, University of British Columbia, 2010
- </li>
- </ol>
-
- <a name="2009"> </a>
- <h2>Publications in 2009</h2>
-
- <!-- Please enter alphabetically by name -->
- <ol>
- <li> <a
- href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, A. Joshi
- <br>
- <strong>Adaptive finite element methods for nonlinear inverse
- problems
- </strong>
- <br>
- Proceedings of the 2009 ACM Symposium on Applied Computing, 2009.
- </li>
-
- <li> <a
- href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, O. Kayser-Herold
- <br>
- <strong>Data Structures and Requirements for hp Finite Element
- Software
- </strong>
- <br>
- ACM Trans. Math. Softw., vol. 36, pp. 4/1-31, 2009.
- </li>
-
- <li> S. Bartle
- <br>
- <strong>Shell finite elements with applications in biomechanics</strong>
- <br>
- M.Sc. thesis, University of Cape Town, South Africa, 2009.
- </li>
-
- <li>
- F. Bassi, C. De Bartolo, <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>, A. Nigro
- <br>
- <strong>A discontinuous Galerkin method for inviscid low Mach number flows
- </strong>
- <br>
- J. Comput. Phys., vol. 228, no. 11, pp. 3996-4011, 2009.
- </li>
-
- <li> B. Brendel, T. Nielsen
- <br>
- <strong>Selection of optimal wavelengths for spectral reconstruction
- in diffuse optical tomography</strong>
- <br>
- J. Biomed. Optics, vol. 14, 034041/1-034041/10, 2009.
- </li>
-
- <li>C. Clason, P. Hepperger
- <br>
- <strong>A forward approach to numerical data assimilation</strong>
- <br>
- SIAM J. Sc. Comput., vol. 31, pp. 3090-3115, 2009
- </li>
-
- <li> B. Cockburn, G. Kanschat, and D. Schötzau
- <br>
- <strong>An equal-order DG method for the incompressible Navier-Stokes
- equations</strong>
- <br>
- J. Sci. Comput., vol. 40, pp. 188-210, 2009.
- <a href="http://dx.doi.org/10.1007/s10915-008-9261-1">DOI: 10.1007/s10915-008-9261-1</a>
- </li>
-
- <li> A. DeSimone, L. Heltai, C. Manigrasso
- <br>
- <strong>Tools for the Solution of PDEs Defined on
- Curved Manifolds with the deal.II Library
- </strong>
- <br>
- Prep. SISSA 42/2009/M.
- </li>
-
- <li>
- F. Freddi, G. Royer-Carfagni
- <br>
- <strong>From Non-Linear Elasticity to Linearized Theory:
- Examples Defying Intuition
- </strong>
- <br>
- J. of Elasticity, vol. 96, pp. 1-26, 2009
- </li>
-
- <li>
- F. Freddi, G. Royer-Carfagni
- <br>
- <strong>Variational models for cleavage and shear fractures
- </strong>
- <br>
- Proceedings of the XIX Congresso Aimeta, Ancona, 2009.
- </li>
-
- <li> T. George, A. Gupta, V. Sarin
- <br>
- <strong>An empirical analysis of the performance of iterative
- solvers for SPD systems
- </strong>
- <br>
- IBM TJ Watson Research Center, Tech. Rep. RC24737, 2009.
- </li>
-
- <li>
- P. Ghysels, G. Samaey, B. Tijskens, P. Van Liedekerke,
- H. Ramon, D. Roose
- <br>
- <strong>Multi-scale simulation of plant tissue deformation
- using a model for individual cell mechanics
- </strong>
- <br>
- Phys. Biol., vol. 6, pp. 016009/1-14, 2009
- </li>
-
- <li>
- S. Gladkov, M. Stiemer, B. Svendsen
- <br>
- <strong>Phase-field-based modeling and simulation of solidification
- and deformation behavior of technological alloys
- </strong>
- <br>
- PAMM, vol. 8, pp. 10547-10548, 2009
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>, M. Lukacova-Medvidova, F. Prill
- <br>
- <strong>Efficient preconditioning for the discontinuous
- Galerkin finite element method by low-order elements</strong>
- <br>
- Appl. Numer. Math., vol. 59, no. 8, pp. 1737-1753, 2009
- </li>
-
- <li>H. K. Hesse,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>Mesh Adaptive Multiple Shooting for Partial Differential
- Equations. Part I: Linear Quadratic Optimal Control Problems</strong>
- <br>
- Journal of Numerical Mathematics, vol. 17, pp. 195-217 2009
- </li>
-
- <li> D. Hyde, R. Schulz, D. Brooks, E. Miller, V. Ntziachristos
- <br>
- <strong>Performance dependence of hybrid x-ray computed
- tomography/fluorescence molecular tomography on the optical
- forward problem</strong>
- <br>
- J. Optical Soc. Amer., vol. 26, pp. 919-923, 2009
- </li>
-
- <li> T. Jetzfellner, D. Razansky, A. Rosenthal, R. Schulz,
- K.-H. Englmeier, V. Ntziachristos
- <br>
- <strong>Performance of iterative optoacoustic tomography with
- experimental data</strong>
- <br>
- Appl. Phys. Lett., vol. 95, pp. 013703/1-3, 2009
- </li>
-
- <li> J. Jung
- <br>
- <strong>Mehrgitterverfahren für FE-Modelle 4. Ordnung
- </strong>
- <br>
- Master's thesis, Universität Siegen, Germany, 2009
- </li>
-
- <li>
- S. Kim
- <br>
- <strong>Analysis of a PML method applied to computation of
- resonances in open systems and acoustic scattering problems</strong>
- <br>
- Ph.D. thesis, Texas A&M University, 2009
- </li>
-
- <li>
- S. Kim, J. E. Pasciak
- <br>
- <strong>The computation of resonances in open systems using a
- perfectly matched layer</strong>
- <br>
- Math. Comp., vol. 78, pp. 1375-1398, 2009
- </li>
-
- <li> N. Klein
- <br>
- <strong>Modelladaptive FE-Techniken bei Elastizitätsproblemen
- mit großen Verformungen
- </strong>
- <br>
- Master's thesis, Universität Siegen, Germany, 2009
- </li>
-
- <li> J. Lorentzon
- <br>
- <strong>Fluid-structure interaction (FSI) case study of a cantilever
- using OpenFOAM and DEAL.II with application to VIV
- </strong>
- <br>
- Master's thesis, Lunds Institute of Technology, Sweden, 2009
- </li>
-
- <li>
- G. Matthies, G. Lube, L. Röhe
- <br>
- <strong>Some remarks on streamline-diffusion methods for inf-sup
- stable discretisations of the generalised Oseen problem
- </strong>
- <br>
- Comp. Meths. Appl. Math. 9 (2009) 4, 1-23.
- </li>
-
- <li> A. M. McMahon
- <br>
- <strong>Modelling the Flow Behaviour of Gas Bubbles in a
- Bubble Column</strong>
- <br>
- M.Sc. thesis, University of Cape Town, South Africa, 2009.
- </li>
-
- <li>
- S. T. Miller, F. Costanzo
- <br>
- <strong>A numerical verification for an unconditionally
- stable FEM for elastodynamics</strong>
- <br>
- Comp. Mech., vol. 43, pp. 223-237, 2009
- </li>
-
- <li>
- M. Olshanskii, G. Lube, T. Heister, J. Löwe
- <br>
- <strong>Grad-div stabilization and subgrid pressure models for the
- incompressible Navier–Stokes equations</strong>
- <br>
- Comp. Meth. Appl. Mech. Eng. V. 198, pp. 3975-3988, 2009
- </li>
-
- <li>
- J. S. Pitt, F. Costanzo
- <br>
- <strong>An adaptive h-refinement algorithm for local damage
- models </strong>
- <br>
- Algorithms, vol. 2, pp. 1281-1300, 2009
- </li>
-
- <li>
- L. Plagne, F. Hülsemann, D. Barthou, J. Jaeger
- <br>
- <strong>Parallel expression template for large vectors
- </strong>
- <br>
- Proceedings of the 8th workshop on Parallel/High-Performance
- Object-Oriented Scientific Computing, European Conference on
- Object-Oriented Programming, 2009.
- </li>
-
- <li> F. Prill, M. Lukacova-Medvidova,
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Smoothed aggregation multigrid for the discontinuous
- Galerkin method
- </strong>
- <br>
- SIAM J. Sci. Comput., vol. 31, no. 5, pp. 3503-3528, 2009.
- </li>
-
- <li>
- F. Prill, M. Lukacova-Medvidova,
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>
- <br>
- <strong>A multilevel discontinuous Galerkin method for the
- compressible Navier-Stokes equations
- </strong>
- <br>
- 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.
- </li>
-
- <li>
- A. Q. Raeini
- <br>
- <strong>Fractured reservoir simulation using finite element method
- with logarithmic shape functions (in Persian)
- </strong>
- <br>
- M. Sc. thesis, Sharif University of Technology, Iran, 2009.
- </li>
-
- <li>
- H. R. Ramay and M. Vendelin
- <br>
- <strong>Diffusion restrictions surrounding mitochondria: a
- mathematical model of heart muscle fibers
- </strong>
- <br>
- Biophys. J., vol. 97, pp. 443-452, 2009.
- </li>
-
- <li>
- R. Rannacher
- <br>
- <strong>Adaptive Finite Element Discretization of Flow
- Problems for Goal-Oriented Model Reduction </strong>
- <br>
- In: Computational Fluid Dynamics 2008 (H. Choi, H.
- G. Choi and J. Y. Yoo, eds.), pp. 31-45, Springer, 2009.
- </li>
-
- <li> B. Rüger, J. Joos, T. Carraro, A. Weber, E. Ivers-Tiffée
- <br>
- <strong>3D Electrode Microstructure Reconstruction and
- Modelling</strong>
- <br>
- ECS Trans. 25, pp. 1211-1220, 2009.
- </li>
-
- <li>
- D. Schötzau, L. Zhu
- <br>
- <strong>A robust a-posteriori error estimator for discontinuous
- Galerkin methods for convection-diffusion equations
- </strong>
- <br>
- Appl. Numer. Math., vol. 59, pp. 2236-2255, 2009
- </li>
-
- <li> N. Schröder
- <br>
- <strong>Simulation eines mikrofluidischen Kanals mit deal.II
- </strong>
- <br>
- Master's thesis, Universität Siegen, Germany, 2009
- </li>
-
- <li> Y. Wang
- <br>
- <strong>Adaptive mesh refinement solution techniques for the
- multigrid S<sub>N</sub> transport equation using a
- higher-order discontinuous finite element method
- </strong>
- <br>
- Ph.D. thesis, Texas A&M University, 2009
- </li>
-
- <li> Y. Wang, W. Bangerth, J. Ragusa
- <br>
- <strong>Three-dimensional h-adaptivity for the multigroup neutron
- diffusion equations
- </strong>
- <br>
- Progress in Nuclear Energy, vol. 51, pp. 543-555, 2009
- </li>
-
- <li> S. Wanka
- <br>
- <strong>Grundkonzepte zur Modelladaptivität bei Hindernisproblemen
- </strong>
- <br>
- Master's thesis, Universität Siegen, Germany, 2009
- </li>
-
- <li> J. White
- <br>
- <strong>Stabilized finite element methods for coupled flow
- and geomechanics</strong>
- <br>
- PhD thesis, Stanford University, 2009.
- </li>
-
- <li> J. Willems
- <br>
- <strong>Numerical Upscaling for Multiscale Flow Problems - Analysis
- and Algorithms </strong>
- <br>
- Südwestdeutscher Verlag für Hochschulschriften, 2009.
- </li>
-
- <li> J. Willems
- <br>
- <strong>Numerical upscaling for multiscale flow problems
- </strong>
- <br>
- Ph.D. thesis, University of Kaiserslautern, Germany, 2009
- </li>
-
- <li> <a href="http://www.ippt.gov.pl/~tyoung"
- target="_top">T. D. Young</a>, E. Romero, and J. E. Roman
- <Br>
- <strong>Finite element solution of the stationary
- Schrödinger equation using standard computational tools
- </strong>
- <br>
- In Proceedings of the International Conference on
- Computational and Mathematical Methods in Science and
- Engineering 2009, Gijon Asturias, Spain, July
- 2009.
- </li>
-
- <li> <a href="http://www.ippt.gov.pl/~tyoung"
- target="_top">T. D. Young</a>
- <br>
- <strong>Exemplifying quantum systems in a finite element
- basis
- </strong>
- <br>
- AIP Conf. Proc., vol. 1148, pp. 285-289 2009.
- </li>
-
- <li> R. Ziegler, B. Brendel, A. Schipper, R. Harbers, M. van Beek,
- H. Rinneberg, T. Nielsen
- <br>
- <strong>Investigation of detection limits for diffuse optical
- tomography systems: I. Theory and experiment
- </strong>
- <br>
- Phys. Med. Biol., vol. 54, pp. 399-412, 2009
- </li>
-
- <li> R. Ziegler, B. Brendel,
- H. Rinneberg, T. Nielsen
- <br>
- <strong>Investigation of detection limits for diffuse optical
- tomography systems: II. Analysis of slab and cup geometry for
- breast imaging
- </strong>
- <br>
- Phys. Med. Biol., vol. 54, pp. 413-431, 2009
- </li>
-
- <li> R. Ziegler, T. Nielsen, T. Koehler, D. Grosnick,
- O. Steinkellner, A. Hagen, R. Macdonald, H. Rinneberg
- <br>
- <strong>Nonlinear reconstruction of absorption and
- fluorescence contrast from measured diffuse transmittance and
- reflectance of a compressed-breast-simulating phantom
- </strong>
- <br>
- Applied Optics, vol. 48, pp. 4651-4662, 2009
- </li>
- </ol>
-
-
-
- <a name="2008"> </a>
- <h2>Publications in 2008</h2>
-
- <!-- Please enter alphabetically by name -->
- <ol>
- <li> <a
- href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>
- <br>
- <strong>A framework for the adaptive finite element solution of
- large-scale inverse problems
- </strong>
- <br>
- SIAM J. Sci. Comput, vol. 30, pp. 2965-2989, 2008
- </li>
-
- <li> <a
- href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, A. Joshi
- <br>
- <strong>Adaptive finite element methods for the solution of
- inverse problems in optical tomography
- </strong>
- <br>
- Inverse Problems, vol. 24, article 034011 (23 pages), 2008
- </li>
-
- <li> E. Bängtsson, B. Lund
- <br>
- <strong>A comparison between two solution techniques to solve
- the equations of glacially induced deformation of an elastic
- Earth
- </strong>
- <br>
- Int. J. Numer. Meth. Engrg., vol. 75, pp. 479-502, 2008
- </li>
-
- <li>
- M. Bartels, A. Joshi, J. C. Rasmussen, E. M. Sevick-Muraca,
- <a
- href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>
- <br>
- <strong>Post-image acquisition excitation light mitigation in NIR
- fluorescent tomography
- </strong>
- <br>
- Proceedings of the IEEE International
- Symposium on Biomedical Imaging, Arlington, VA, 2008
- </li>
-
- <li>
- B. Brendel, R. Ziegler, T. Nielsen
- <br>
- <strong>Algebraic reconstruction techniques for spectral
- reconstruction in diffuse optical tomography
- </strong>
- <br>
- Applied Optics, vol. 47, pp. 6392-6403, 2008
- </li>
-
- <li> D. Boffi, L. Gastaldi, <a
- href="http://www-dimat.unipv.it/heltai/"
- target="_top">L. Heltai</a>,
- C. S. Peskin
- <br>
- <strong>On the hyper-elastic formulation of
- the immersed boundary method
- </strong>
- <br>
- Computer Methods in Applied Mechanics and Engineering,
- vol. 197, pp. 2210-2231, 2008
- </li>
-
- <li> B. Carnes, G. F. Carey
- <br>
- <strong>Local boundary value problems for the error in FE
- approximation of non-linear diffusion systems
- </strong>
- <br>
- Int. J. for Numer. Methods Engrg., vol. 73,
- pp. 665-684, 2008
- </li>
-
- <li> N. Djilali, P. C. Sui
- <br>
- <strong>Transport phenomena in fuel cells: from microscale to
- macroscale
- </strong>
- <br>
- Int. J. of Comput. Fluid Dynam., vol. 22,
- pp. 115-133, 2008
- </li>
-
- <li> R. Fosdick, F. Freddi, G. Royer-Carfagni
- <br>
- <strong>Bifurcation instability in
- linear elasticity with the constraint of local injectivity
- </strong>
- <br>
- J. of Elasticity, vol. 90, pp. 99-126, 2008
- </li>
-
- <li>
- M. Geiger
- <br>
- <strong>Vergleich dreier Zeitschrittverahren zur numerischen
- Lösung der akustischen Wellengleichung</strong>
- <br>
- Diploma thesis, University of Heidelberg, Germany, 2008
- </li>
-
- <li>
- P. Ghysels, G. Samaey, B. Tijskens,
- H. Ramon, D. Roose
- <br>
- <strong>Multi-scale simulation of plant tissue deformation
- using a model for individual cell behavior
- </strong>
- <br>
- Report TW 522, Department of Computer Science, K.U. Leuven, Belgium,
- 2008
- <br>
-
- <li> C. Giavarini, M. L. Santarelli, R. Natalini, F. Freddi
- <br>
- <strong>A non linear model of
- sulphation of porous stones: numerical simulations and preliminary
- laboratory assessments
- </strong>
- <br>
- J. of Cultural Heritage, vol. 9, pp. 14-22, 2008
- </li>
-
- <li> <a href="http://www.math.unibas.ch/~grote/" target="_top">M. Grote</a>, <a
- href="http://www.math.unibas.ch/~schneeba/" target="_top">A.
- Schneebeli</a>, <a href="http://www.math.ubc.ca/~schoetzau/" target="_top">D. Schötzau</a>
- <br>
- <strong>Interior penalty discontinuous Galerkin method for
- Maxwell's equations: optimal L<sup>2</sup>-norm estimates
- </strong>
- <br>
- IMA J. Numer. Anal., vol. 28, pp. 440-468, 2008
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Multitarget error estimation and adaptivity in aerodynamic flow simulations
- </strong>
- <br>
- SIAM J. Sci. Comput., vol. 31, no. 1, pp. 708-731, 2008
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods</strong>
- <br>
- In H. Deconinck, editor,
- VKI LS 2008-08: 35th CFD/ADIGMA course on very high order discretization methods, Oct. 13-17, 2008.
- <br>
- Von Karman Institute for Fluid Dynamics, Rhode Saint Genese, Belgium (2008).
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>, P. Houston
- <br>
- <strong>An optimal order interior penalty discontinuous
- Galerkin discretization of the compressible Navier-Stokes
- equations
- </strong>
- <br>
- J. Comput. Phys., vol. 227, no. 22, pp. 9670-9685, 2008
- </li>
-
- <li>
- T. Heister
- <br>
- <strong>Vorkonditionierunsstrategien für das
- stabilisierte Oseen-Problem</strong>
- <br>
- Diploma thesis, University of Göttingen, Germany, 2008
- </li>
-
- <li><a
- href="http://www-dimat.unipv.it/heltai/"
- target="_top">L. Heltai</a>
- <br>
- <strong>On the stability of the finite element immersed
- boundary method</strong>
- <br>
- Computers and Structures, vol. 86, pp. 598-617, 2008
- </li>
-
- <li> A. Joshi, <a
- href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, E. Sevick
- <br>
- <strong>Non-Contact Fluorescence Optical Tomography with
- Adaptive Finite Element Methods
- </strong>
- <br>
- 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
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>Robust smoothers for high order discontinuous Galerkin
- discretizations of advection-diffusion problems</strong>
- <br>
- J. Comput. Appl. Math., vol. 218, pp. 53-60, 2008.
- <br>
- <a href="http://www.isc.tamu.edu/publications-reports/tr/0701.pdf">(Preprint)</a>
- </li>
-
- <li> <a
- href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>, <a
- href="http://www.math.ubc.ca/~schoetzau/"
- target="_top">D. Schötzau</a>
- <br>
- <strong>Energy norm a-posteriori error estimation for divergence-free
- discontinuous Galerkin approximations of the Navier-Stokes
- equations
- </strong>
- <br>
- Int. J. Numer. Methods Fluids, vol. 57, pp. 1093-1113, 2008.
- <a href="http://dx.doi.org/10.1002/fld.1795">DOI: 10.1002/fld.1795</a>
- </li>
-
- <li> D. K. Khalmanova, F. Costanzo
- <br>
- <strong>A space-time discontinuous Galerkin finite element method for
- fully coupled linear thermo-elasto-dynamic problems with strain and
- heat flux discontinuities
- </strong>
- <br>
- Comput. Meth. Appl. Mech. Engrg., vol. 197, pp. 1323-1342, 2008
- </li>
-
- <li> L. Khasina
- <br>
- <strong>Mathematische Behandlung von Mischungen
- elastoplastischer Substanzen
- </strong>
- <br>
- PhD thesis, University of Bonn, Germany, 2008
- </li>
-
- <li> M. Kronbichler, G. Kreiss
- <br>
- <strong>A hybrid level–set–Cahn–Hilliard model for
- two-phase flow
- </strong>
- <br>
- Proceedings of the 1st European Conference on Microfluidics, accepted
- for publication. Microfluidics 2008, Bologna, Italy, December
- 10–12, 2008.
- </li>
-
- <li>
- T. Leicht, <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Anisotropic mesh refinement for discontinuous Galerkin methods
- in two-dimensional aerodynamic flow simulations
- </strong>
- <br>
- Int. J. Numer. Meth. Fluids, vol. 56, no. 11, pp. 2111-2138, 2008
- </li>
-
- <li>
- J. Löwe
- <br>
- <strong>Stabilisierung durch lokale Projektion für
- inkompressible Strömungsprobleme</strong>
- <br>
- Diploma thesis, University of Göttingen, Germany, 2008
- </li>
-
- <li>
- M. Neytcheva and E. Bängtsson
- <br>
- <strong>Preconditioning of nonsymmetric saddle point systems as
- arising in modelling of viscoelastic problems
- </strong> <br>
- ETNA, vol. 29, pp. 193-211, 2008
- 2008
- </li>
-
- <li>
- J. S. Pitt, F. Costanzo
- <br>
- <strong>Theory and simulation of a brittle damage model in
- thermoelastodynamics
- </strong> <br>
- Proceedings of the 8th World Congress on Computational
- Mechanics (WCCM 8), Venice, Italy, 2008
- </li>
-
- <li>
- K. Schmid
- <br>
- <strong>Theory and numerics of a reconstruction algorithm for a
- problem from acoustic microscopy
- </strong> <br>
- Diploma thesis, Technical University of Munich, Germany,
- 2008
- </li>
-
- <li> M. Secanell, K. Karan, A. Suleman, N. Djilali
- <br>
- <strong>Optimal design of ultralow-platinum PEMFC anode electrodes
- </strong>
- <br>
- Journal of The Electrochemical Society, vol. 155, pp. B125-B134, 2008
- </li>
-
- <li> M. Secanell, R. Songprakorp, A. Suleman, N. Djilali
- <br>
- <strong>Multi-objective optimization of a polymer electrolyte
- fuel cell membrane electrode assembly
- </strong>
- <br>
- Energy & Environmental Science, vol. 1, pp. 378-388, 2008
- </li>
-
- <li> J. A. White, R. I. Borja
- <br>
- <strong>Stabilized low-order finite elements for coupled
- solid-deformation/fluid-diffusion and their application to
- fault zone transients
- </strong>
- <br>
- Comput. Meth. Appl. Mech. Engrg., vol. 197, pp. 4353-4366, 2008
- </li>
-
- <li> T. Wick
- <br>
- <strong>Untersuchung von Kopplungsmechanismen von
- Fluid-Struktur-Interaktion
- </strong>
- <br>
- Master's thesis, Universität Siegen, Germany, 2008
- </li>
-
- <li> R. Ziegler
- <br>
- <strong>Modeling photon transport and reconstruction of
- optical properties for performance assessment of laser and
- fluorescence mammographs and analysis of clinical data
- </strong>
- <br>
- PhD thesis, Freie Universität Berlin, 2008
- </li>
- </ol>
-
-
- <a name="2007"> </a>
- <h2>Publications in 2007</h2>
- <!-- Please enter alphabetically by name -->
- <ol>
- <li> N. Antonic, M. Vrdoljak
- <br>
- <strong>Gradient methods for multiple state optimal design problems
- </strong>
- <br>
- Ann. Univ. Ferrara, vol. 53, pp. 177-187, 2007
- </li>
-
- <li>
- P. F. Antonietti,
- <a href="http://www-dimat.unipv.it/heltai" >L. Heltai</a>
- <br>
- <strong>Numerical validation of a class of mixed
- discontinuous Galerkin methods for Darcy flow
- </strong>
- <br>
- Computer Methods in Applied Mechanics and Engineering,
- vol. 196, pp. 4505-4520, 2007
- </li>
-
- <li> <a
- href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>,
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>deal.II — a general-purpose object-oriented finite
- element library
- </strong>
- <br>
- ACM Transactions on Mathematical Software, vol. 33, no. 4, article
- 24, 2007
- </li>
-
- <li> <a
- href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, A. Joshi, E. Sevick
- <br>
- <strong>Inverse biomedical imaging using separately adapted meshes
- for parameters and forward model variables
- </strong>
- <br>
- Proceedings of the IEEE International Symposium on Biomedical Imaging,
- Arlington, VA, pp. 1368-1371, 2007
- </li>
-
- <li> E. Bängtsson, M. Neytcheva
- <br>
- <strong>Finite Element Block-Factorized Preconditioners
- </strong>
- <br>
- Technical Report 2007-008, Uppsala University, Sweden, 2007
- </li>
-
- <li> D. Boffi, L. Gastaldi, <a
- href="http://www-dimat.unipv.it/heltai/" target="_top">L. Heltai</a>
- <br>
- <strong>On the CFL condition for the finite element immersed
- boundary method</strong>
- <br>
- Computers & Structures, vol. 85, pp. 775-783, 2007
- (<a href="http://dx.doi.org/10.1016/j.compstruc.2007.01.009" >DOI</a>)
- </li>
-
- <li> D. Boffi, L. Gastaldi, <a
- href="http://www-dimat.unipv.it/heltai/"
- target="_top">L. Heltai</a>
- <br>
- <strong>Numerical stability of the finite element immersed boundary method</strong>
- <br>
- Mathematical Models and Methods in Applied Sciences, vol. 17,
- pp. 1479-1505, 2007
- </li>
-
- <li> M. Calhoun-Lopez, M. D. Gunzburger
- <br>
- <strong>The efficient implementation of a finite element,
- multi-resolution viscosity method for hyperbolic conservation
- laws
- </strong>
- <br>
- Journal of Computational Physics, vol. 225, pp. 1288-1313, 2007
- </li>
-
- <li> B. Carnes, G. F. Carey
- <br>
- <strong>Estimating spatial and parameter error in
- parameterized nonlinear reaction-diffusion equations
- </strong>
- <br>
- Communications in Numerical Methods in Engineering, vol. 23,
- pp. 835-854, 2007
- </li>
-
-
- <li> 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
- <br>
- <strong>Dynamically identifying and tracking contaminants in water
- bodies
- </strong>
- <br>
- International Conference on Computational Science ICCS 2007,
- vol. 4487 of Springer Lecture Notes in Computer Science,
- pp. 1002-1009, 2007
- </li>
-
- <li> F. Freddi, M. Frémond
- <br>
- <strong>Collision and Fractures: a predictive theory
- </strong>
- <br>
- Proceedings of the EuroSim Conference, Lubiana, Slovenia,
- 9-13 September, 2007
- </li>
-
- <li> P.K. Galenko, S. Reutzel, D. M. Herlach, D. Danilov, B. Nestler
- <br>
- <strong>Modelling of dendritic solidification in undercooled
- dilute Ni-Zr melts
- </strong>
- <br>
- Acta Materialia, vol. 55, pp. 6834-6842, 2007
- </li>
-
- <li> A. Garny, J. Cooper, P. J. Hunt
- <br>
- <strong>Toward a VPH/Physiome ToolKit
- </strong>
- <br>
- Wiley Interdisciplinary Reviews: Systems Biology and Medicine,
- vol. 2, pp. 134-147, 2010
- </li>
-
- <li> T. Ha, C. Shin
- <br>
- <strong>Magnetotelluric inversion via reverse time migration
- algorithm of seimic data
- </strong>
- <br>
- J. Comput. Phys., vol. 225, pp. 237-262, 2007
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Adjoint consistency analysis of Discontinuous Galerkin discretizations
- </strong>
- <br>
- SIAM J. Numer. Anal., vol. 45, no. 6, pp. 2671-2696, 2007
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Error estimation and adjoint based refinement for an adjoint
- consistent DG discretization of the compressible Euler equations
- </strong>
- <br>
- Int. J. Computing Science and Mathematics, vol. 1, pp. 207-220, 2007
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>DG discretizations for compressible flows: Adjoint
- consistency analysis, error estimation and adaptivity
- </strong>
- <br>
- 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
- </li>
-
- <li> P. Hepperger
- <br>
- <strong>Ein POD-basierter Ansatz zur numerischen Lösung eines
- Datenassimilationsproblems am Beispiel einer linearen
- Diffusions-Konvektions-Gleichung
- </strong> <br>
- Diploma thesis, Technical University of Munich, Germany,
- 2007</li>
-
- <li> Christian D. Kamm
- <br>
- <strong>A posteriori error estimation in numerical methods
- for solving self-adjoint eigenvalue problems
- </strong>
- <br>
- Diploma thesis, TU Berlin, Germany, 2007
- </li>
-
- <li> O. Kayser-Herold, H.G. Matthies
- <br>
- <strong>A unified least-squares formulation for fluid-structure interaction
- problems
- </strong>
- <br>
- Computers and Structures, vol. 85, pp. 998-1011, 2007
- </li>
-
- <li> <a
- href="http://numerik.uni-hd.de/~baer"
- target="_top">B. Janssen</a>,
- <br>
- <strong>Vergleich verschiedener Finite-Elemente-Approximationen
- zur numerischen Lösung der Plattengleichung</strong>
- <br>
- Diploma thesis, University of Heidelberg, Germany, 2007.
- </li>
-
- <li> A. Joshi, <a
- href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, R. Sharma, J. Rasmussen, W. Wang,
- E. Sevick
- <br>
- <strong>Molecular tomographic imaging of lymph nodes with
- NIR fluorescence
- </strong>
- <br>
- Proceedings of the IEEE International Symposium on Biomedical Imaging,
- Arlington, VA, pp. 564-567, 2007
- </li>
-
- <li> B. Nestler, D. Danilov, A. Bracchi,
- Y.-L. Huang, T. Niermann, M. Seibt and S. Schneider
- <br>
- <strong>A metallic glass composite: Phase-field simulations
- and experimental analysis of microstructure evolution
- </strong>
- <br>
- Materials Science and Engineering: A, vol. 452-453, pp. 8-14, 2007
- </li>
-
- <li>
- A. Nigro
- <br>
- <strong>Discontinuous Galerkin Methods for inviscid low Mach
- number flows
- </strong> <br>
- Ph.D. thesis, University of Calabria, 2007
- </li>
-
- <li> P. J. Phillips and M. F. Wheeler
- <br>
- <strong>A coupling of mixed and continuous Galerkin finite
- element methods for poroelasticity II: the discrete-in-time case
- </strong>
- <br>
- Computational Geosciences, vol. 11, pp. 145-158, 2007
- </li>
-
- <li> H.-J. Reinhardt, D. N. Hào, J. Frohne and F.-T. Suttmeier
- <br>
- <strong>Numerical solution of Inverse Heat Conduction
- Problems in two spatial dimensions
- </strong>
- <br>
- J. Inverse and Ill-Posed Problems, vol. 5, pp. 19-36, 2007
- </li>
-
- <li>
- L. Röhe
- <br>
- <strong>Residuale Stabilisierung für Finite Elemente Verfahren
- bei inkompressiblen Strömungen</strong>
- <br>
- Diploma thesis, University of Göttingen, Germany, 2007
- </li>
-
- <li> M. Schmidt
- <br>
- <strong>Systematic discretization of input/output maps and
- other contributions to the control of distributed parameter
- systems
- </strong>
- <br>
- Ph.D. thesis, TU Berlin, Germany, 2007
- </li>
-
- <li> M. Secanell, B. Carnes, A. Suleman, N. Djilali
- <br>
- <strong>Numerical optimization of proton exchange membrane fuel cell
- cathodes
- </strong>
- <br>
- Electrochimica Acta, vol. 52, pp. 2668-2682, 2007
- </li>
-
- <li> M. Secanell, K. Karan, A. Suleman, N. Djilali
- <br>
- <strong>Multi-variable optimization of PEMFC cathodes using
- an agglomerate model
- </strong>
- <br>
- Electrochimica Acta, vol. 52, pp. 6318-6337, 2007
- </li>
-
- <li>
- M. Steigemann, M. Fulland, M. Specovius-Neugebauer, H. A. Richard
- <br>
- <strong>Simulation of crack paths in functionally graded materials
- </strong>
- <br>
- PAMM, vol. 7, pp. 4030029-4030030, 2007
- </li>
-
- <li> M. Steigemann, M. Fulland
- <br>
- <strong>On the computation of the pure Neumann problem in
- 2-dimensional elasticity
- </strong>
- <br>
- International Journal of Fracture, vol. 146, pp. 265-277, 2007
- </li>
-
- <li> R. Ziegler, T. Nielsen, T. Koehler, D. Grosenick,
- O. Steinkellner, A. Hagen, R. Macdonald, H. Rinneberg
- <br>
- <strong>Reconstruction of absorption and fluorescence
- contrast for scanning time-domain fluorescence mammography
- </strong>
- <br>
- Optical Tomography and Spectroscopy of Tissue VII, Proc. SPIE
- vol. 6434, 64340H/1-11, 2007
- </li>
- </ol>
-
-
-
- <a name="2006"> </a>
- <h2>Publications in 2006</h2>
-
- <ol>
-
- <li> M. Allmaras
- <br>
- <strong>Optimal Design of Periodic Microstructures by the
- Inverse Homogenization Method
- </strong>
- <br>
- Diploma Thesis, Technical University Munich, Germany, 2006
- </li>
-
- <li> N. Antonic, M. Vrdoljak
- <br>
- <strong>Sequential laminates in multiple state optimal design problems
- </strong>
- <br>
- Mathematical Problems in Engineering, vol. 2006, pp. 1-14, 2006
- </li>
-
- <li>
- P. F. Antonietti
- <br>
- <strong>Domain decomposition, spectral correctness and
- numerical testing of discontinuous Galerkin methods
- </strong>
- <br>
- Ph.D. thesis, University of Pavia, Italy, 2007
- </li>
-
- <li> E. Bängtsson, B. Lund
- <br>
- <strong>A comparison between two approaches to solve the equations of
- isostasy
- </strong>
- <br>
- Institute for Parallel Processing (BIS 21++) Technical Report 2006-03,
- Bulgarian Academy of Sciences, 2006
- </li>
-
- <li> E. Bängtsson, B. Lund
- <br>
- <strong>A comparison between two approaches to solve the equations of
- isostasy
- </strong>
- <br>
- Technical Report 2006-051, Uppsala University, Sweden, 2006
- </li>
-
- <li> E. Bängtsson, M. Neytcheva
- <br>
- <strong>Numerical simulations of glacial rebound using
- preconditioned iterative solution methods
- </strong>
- <br>
- Applications of Mathematics, vol. 50, pp. 183-201, 2006
- </li>
-
- <li> E. Bängtsson, M. Neytcheva
- <br>
- <strong>An agglomerate multilevel preconditioner for linear
- isostasy saddle point problems
- </strong>
- <br>
- Proceedings of Large-Scale Scientific Computing: 5th
- International Conference (I. Lirkov, S. Margenov,
- J. Wasniewski, eds), pp. 113-120, 2006
- </li>
-
- <li> B. Carnes, N. Djilali
- <br>
- <strong>Analysis of coupled proton and water transport in a
- PEM fuel cell using the binary friction membrane model
- </strong>
- <br>
- Electrochimica Acta, vol. 52, pp. 1038-1052, 2007
- </li>
-
- <li> D. Danilov, B. Nestler
- <br>
- <strong>Phase-field simulations of eutectic solidification
- using an adaptive finite element method
- </strong>
- <br>
- International Journal of Modern Physics B, vol. 20,
- pp. 853-867, 2006
- </li>
-
- <li> J. Frohne
- <br>
- <strong>Numerische Lösung des inversen
- Wärmeleitproblems in zwei
- Ortsdimensionen zur Identifizierung von Randbedingungen
- </strong>
- <br>
- Diploma thesis, Universität Siegen, Germany, 2009
- </li>
-
- <li> <a href="http://www.math.unibas.ch/~grote/" target="_top">M. Grote</a>, <a
- href="http://www.math.unibas.ch/~schneeba/" target="_top">A.
- Schneebeli</a>, <a href="http://www.math.ubc.ca/~schoetzau/" target="_top">D. Schötzau</a>
- <br>
- <strong> Discontinuous Galerkin Finite Element Method for the Wave Equation
- </strong>
- <br>
- SIAM J. Numer. Anal, vol. 44, pp. 2408-2431, 2006
- </li>
-
- <li> T. Ha, C. Shin
- <br>
- <strong>Two dimensional magnetotelluric inversion via reverse
- time migration algorithm
- </strong>
- <br>
- Abstracts of the SEG Annual Meeting in New Orleans,
- pp. 830-835, 2006
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Error estimation and adjoint-based adaptation in aerodynamics
- </strong>
- <br>
- In P. Wesseling, E. Onate, J. Periaux, eds.,
- Proceedings of the ECCOMAS CFD 2006, Sept. 5-8, Egmond aan Zee,
- The Netherlands, 2006
- </li>
-
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Derivation of an adjoint consistent discontinuous Galerkin
- discretization of the compressible Euler equations
- </strong>
- <br>
- In G. Lube and G. Rapin, eds.,
- Proceedings of the BAIL 2006 Conference, 2006
- </li>
-
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Adaptive discontinuous Galerkin methods with
- shock-capturing for the compressible Navier-Stokes equations
- </strong>
- <br>
- Int. J. Numer. Meth. Fluids, vol. 51, pp. 1131-1156, 2006
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>, P. Houston
- <br>
- <strong>Symmetric Interior Penalty DG Methods for the
- Compressible Navier-Stokes Equations I: Method Formulation
- </strong>
- <br>
- Int. J. Numer. Anal. Model., vol. 3, pp. 1-20, 2006.
- </li>
-
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>, P. Houston
- <br>
- <strong>Symmetric Interior Penalty DG Methods for the
- Compressible Navier-Stokes Equations II: Goal-Oriented A
- Posteriori Error Estimation
- </strong>
- <br>
- Int. J. Numer. Anal. Model., vol. 3, pp. 141-162, 2006
- </li>
-
- <li> <a href="http://www-dimat.unipv.it/heltai/">L. Heltai</a>
- <br>
- <strong>The Finite Element Immersed Boundary Method
- </strong> <br>
- Ph.D. thesis, Università di Pavia, Dipartimento di Matematica "F. Casorati",
- 2006
- </li>
-
- <li> K. Hwang, T. Pan, A. Joshi, J. C. Rasmussen, <a
- href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>,
- E. Sevick-Muraca
- <br>
- <strong>Influence of excitation light rejection on forward model
- mismatch in optical tomography
- </strong>
- <br>
- Phys. Med. Biol., vol. 51, pp. 5889-5902, 2006
- </li>
-
- <li> A. Joshi, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, E. Sevick-Muraca
- <br>
- <strong>Non-contact fluorescence optical tomography with scanning
- patterned illumination
- </strong>
- <br>
- Optics Express, vol. 14,
- pp. 6516-6534, 2006
- </li>
-
- <li> A. Joshi, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, K. Hwang, J. C. Rasmussen,
- E. Sevick-Muraca
- <br>
- <strong>Fully adaptive FEM based fluorescence optical tomography from
- time-dependent measurements with area illumination and detection
- </strong>
- <br>
- Med. Phys., vol. 33,
- pp. 1299-1310, 2006
- </li>
-
- <li> A. Joshi, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, E. Sevick-Muraca
- <br>
- <strong>Non-contact fluorescence optical tomography with scanning
- illumination
- </strong>
- <br>
- Proceedings of the IEEE International Symposium on Biomedical Imaging,
- Arlington, VA, 2006, pp. 582-585, 2006
- </li>
-
- <li> A. Joshi, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, K. Hwang, J. C. Rasmussen,
- E. Sevick-Muraca
- <br>
- <strong>Plane wave fluorescence tomography with adaptive finite
- elements
- </strong>
- <br>
- Optics Letters, vol. 31,
- pp. 193-195, 2006
- </li>
-
- <li> O. Kayser-Herold
- <br>
- <strong>Least-Squares Methods for the Solution of Fluid-Structure
- Interaction Problems
- </strong>
- <br>
- Ph.D. thesis, TU-Braunschweig, Germany, 2006
- <br>
- Available online through <a
- href="http://www.digibib.tu-bs.de/?docid=00000035"
- target="_top">this link</a>
- </li>
-
- <li>
- T. Leicht
- <br>
- <strong> Anisotropic Mesh Refinement for Discontinuous Galerkin
- Methods in Aerodynamic Flow Simulations
- </strong>
- <br>
- Diploma thesis, TU Dresden, 2006
- <br>
- Available online through <a
- href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/publications/publications.html#supervised"
- target="_top">this link</a>
- </li>
-
- <li> D. Oeltz
- <br>
- <strong>Ein Raum-Zeit Dünngitterverfahren zur Diskretisierung
- parabolischer Differentialgleichungen
- </strong>
- <br>
- Ph.D. thesis, University of Bonn, Germany, 2006
- </li>
-
- <li> M. Schmidt
- <br>
- <strong>Low-dimensional I/O modeling of distributed parameter
- systems
- </strong>
- <br>
- Proc. Appl. Math. Mech., vol. 6, pp. 15-18, 2006
- </li>
-
- </ol>
-
-
- <a name="2005"> </a>
- <h2>Publications in 2005</h2>
-
- <ol>
-
- <li> M. Anderson, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, G. Carey
- <br>
- <strong>Analysis of parameter sensitivity and experimental
- design for a class of nonlinear partial differential
- equations
- </strong>
- <br>
- International Journal for Numerical Methods in Fluids, vol. 48,
- pp. 583-605, 2005
- </li>
-
- <li> <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, A. Joshi, E. Sevick-Muraca
- <br>
- <strong>Adaptive finite element methods for increased
- resolution in fluorescence optical tomography
- </strong>
- <br>
- Progress in Biomedical Optics and Imaging, vol. 6,
- pp. 318-329, 2005
- </li>
-
- <li> D. Boffi, L. Gastaldi, <a
- href="http://www-dimat.unipv.it/heltai/" target="_top">L. Heltai</a>
- <br>
- <strong>The finite element immersed boundary method: model, stability, and numerical
- results</strong>
- <br>
- In Schrefler Papadrakakis, Onate, eds., Computational Methods for
- Coupled Problems in Science and Engineering, 2005
- </li>
-
- <li> D. Boffi, L. Gastaldi, <a
- href="http://www-dimat.unipv.it/heltai/" target="_top">L. Heltai</a>
- <br>
- <strong>Stability results and algorithmic strategies for the finite
- element approach to the immersed boundary method
- </strong>
- <br>
- Proceeding of the Sixth European Conference on Numerical Mathematics
- and Advanced Applications (ENUMATH 2005), pages 557-566, 2005
- </li>
-
- <li> M. Calhoun-Lopez, M. D. Gunzburger
- <br>
- <strong>A Finite Element, Multiresolution Viscosity Method
- for Hyperbolic Conservation Laws
- </strong>
- <br>
- SIAM J. Numer. Anal., vol. 43, pp. 1988-2011, 2005
- </li>
-
- <li> B. Carnes, N. Djilali
- <br>
- <strong>Systematic parameter estimation for PEM fuel cell models
- </strong>
- <br>
- Journal of Power Sources, vol. 144, pp. 83-93, 2005
- </li>
-
- <li>
- B. Cockburn,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>,
- <a href="http://www.math.ubc.ca/~schoetzau/" target="_top">D. Schötzau</a>
- <br>
- <strong>A locally conservative LDG method for the incompressible Navier- Stokes equations</strong>
- <br>
- Math. Comput., vol. 74, pp. 1067-1095, 2005
- </li>
-
- <li>
- B. Cockburn,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>,
- <a href="http://www.math.ubc.ca/~schoetzau/" target="_top">D. Schötzau</a>
- <br>
- <strong>The Local Discontinuous Galerkin Method for Linear
- Incomressible Fluid Flow: a Review</strong>
- <br>
- Comput. & Fluids, vol. 34, pp. 491-506, 2005
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong>Discontinuous Galerkin methods for compressible flows:
- higher order accuracy, error estimation and adaptivity
- </strong>
- <br>
- In H. Deconinck and M. Ricchiuto, editors,
- VKI LS 2006-01: CFD - Higher Order Discretization Methods,
- November 14-18, 2005, Rhode Saint Genese, Belgium.
- <br>
- von Karman Institute for Fluid Dynamics (2005)
- </li>
-
- <li> A. Joshi
- <br>
- <strong>Adaptive finite element methods for fluorescence enhanced
- optical tomography
- </strong>
- <br>
- Ph.D. thesis, Texas A&M University, 2005
- </li>
-
- <li> A. Joshi, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, A. B. Thompson, E. Sevick-Muraca
- <br>
- <strong>Experimental fluorescence optical tomography using
- adaptive finite elements and planar illumination with
- modulated excitation light
- </strong>
- <br>
- Progress in Biomedical Optics and Imaging, vol. 6,
- pp. 351-358, 2005
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>Block Preconditioners for LDG Discretizations of
- Linear Incompressible Flow Problems</strong>
- <br>
- J. Sci. Comput., vol. 22, pp. 381-394, 2005
- </li>
-
- <li> O. Kayser-Herold, H. G. Matthies
- <br>
- <strong>Least squares finite element methods for fluid-structure
- interaction problems
- </strong>
- <br>
- Computers & Structures, vol. 83, pp. 191-207, 2005
- </li>
-
- <li> R. Li
- <br>
- <strong>On multi-mesh h-adaptive methods</strong>
- <br>
- J. Sci. Comput., vol. 24, pp. 321-341, 2005
- <br>
- (This paper uses <a
- href="http://dsec.pku.edu.cn/~rli/software_e.php"
- target="_top">AFEPack</a> which in turn uses deal.II's linear
- algebra library.)
- </li>
-
- <li> M. Mu
- <br>
- <strong>PDE.MART: A network-based problem-solving environment
- for PDEs
- </strong>
- <br>
- ACM Trans. Math. Software, vol. 31, pp. 508-531, 2005
- </li>
-
- <li> B. Nestler, D. Danilov, P. Galenko
- <br>
- <strong>Crystal growth of pure substances: Phase-field simulations in
- comparison with analytical and experimental results
- </strong>
- <br>
- Journal of Computational Physics, vol. 207, pp. 221-239, 2005
- </li>
-
- <li> T. Nielsen, T. Koehler, M. van der Mark, G. t'Hooft
- <br>
- <strong>Fully 3D reconstruction of attenuation for diffuse
- optical tomography using a finite element model
- </strong>
- <br>
- Nuclear Science Symposium Record, vol. 4, pp. 2283-2285, 2005
- </li>
-
- <li> Q. Ouyang, K. Xiu
- <br>
- <strong>Simulation Study of Reduced Self-Heating in Novel
- Thin-SOI Vertical Bipolar Transistors
- </strong>
- <br>
- Simulation of Semiconductor Processes and Devices, pp. 55-58, 2005
- </li>
-
- <li> M. Polner
- <br>
- <strong>Galerkin least-squares stabilization operators for the
- Navier-Stokes equations, A unified approach
- </strong>
- <br>
- Ph.D. thesis, University of Twente, The Netherlands, 2005
- </li>
-
- <li> R. B. Schulz, G. Echner, H. Ruehle,
- W. Stroh, J. Vierling, T. Vogt, J. Peter, W. Semmler
- <br>
- <strong>Development of a fully rotational non-contact fluorescence tomographer
- for small animals
- </strong>
- <br>
- IEEE Micro-imaging Conference, IEEE Nuclear Science Symposium
- Conference Record, pp. 2391-2393, 2005
- </li>
-
-
- <li> R. B. Schulz, J. Peter, W. Semmler, C. D'andrea, G. Valentini, R. Cubeddu
- <br>
- <strong>Quantifiability and Image Quality in Noncontact Fluorescence Tomography
- </strong>
- <br>
- in: Photon Migration and Diffuse-Light Imaging II, K. Licha
- and R. Cubeddu (eds.), SPIE press, 2005
- </li>
-
- </ol>
-
-
-
- <a name="2004"> </a>
- <h2>Publications in 2004</h2>
-
- <ol>
- <li> <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>,
- <br>
- <strong>A framework for the adaptive finite element solution
- of large inverse problems. I. Basic techniques
- </strong>
- <br>
- ICES Report 2004-39, 2004.
- </li>
-
- <li> <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, <a
- href="http://www.math.unibas.ch/~grote/"
- target="_top">M. Grote</a>, C. Hohenegger
- <br>
- <strong>Finite Element Method For Time Dependent Scattering:
- Nonreflecting Boundary Condition, Adaptivity, and Energy
- Decay
- </strong>
- <br>
- Computer Methods in Applied Mechanics and Engineering,
- vol. 193, pp. 2453-2482, 2004
- </li>
-
- <li> D. Boffi, L. Gastaldi, <a
- href="http://www-dimat.unipv.it/heltai/" target="_top">L. Heltai</a>
- <br>
- <strong> A finite element approach to the immersed boundary method
- </strong>
- <br>
- Progress in Engineering Computational Technology, vol. 12,
- pp. 271-298, 2004
- </li>
-
-
- <li> G. Carey, M. Anderson, B. Carnes, B. Kirk
- <br>
- <strong>Some aspects of adaptive grid technology related to
- boundary and interior layers
- </strong>
- <br>
- Journal of Computational and Applied Mathematics, vol. 166,
- pp. 55-86, 2004
- </li>
-
- <li> G. Carey, W. Barth, J. A. Woods, B. Kirk,
- M. Anderson, S. Chow, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>
- <br>
- <strong>Modeling error and constitutive relations in
- simulation of flow and transport
- </strong>
- <br>
- International Journal for Numerical Methods in Fluids,
- vol. 46, pp. 1211-1236, 2004
- </li>
-
- <li> S. Chow, G. F. Carey, M. L. Anderson
- <br>
- <strong>Finite element approximations of a glaciology problem.
- </strong>
- <br>
- ESAIM: Mathematical Modelling and Numerical Analysis (M2AN),
- vol. 38, pp. 741-756, 2004.
- </li>
-
- <li> C. Fröbel
- <br>
- <strong>Tikhonov-Regularisierung zur Parameteridentifikation bei elliptischen und parabolischen Modellgleichungen.
- </strong>
- <br>
- Diploma thesis, Universität Bremen, Germany, 2004
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>, P. Houston
- <br>
- <strong> Goal-Oriented A Posteriori Error Estimation
- for Multiple Target Functionals
- </strong>
- <br>
- in M. Feistauer, V. Doleji, P. Knobloch and K. Najzar,
- editors, Numerical Mathematics and Advanced Applications,
- ENUMATH 2003, pp. 410-419, Springer-Verlag, 2004
- </li>
-
- <li> U. Hasler, <a
- href="http://www.math.unibas.ch/~schneeba/" target="_top">A.
- Schneebeli</a>, <a
- href="http://www.math.ubc.ca/~schoetzau/" target="_top">D.
- Schötzau</a>
- <br>
- <strong>Mixed finite element approximation of incompressible
- MHD problems based on weighted regularization
- </strong>
- <br>
- Applied Numerical Mathematics, vol. 51, pp. 19-45, 2004
- </li>
-
- <li> A. Joshi, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, E. Sevick-Muraca
- <br>
- <strong>Adaptive finite element modeling of optical
- fluorescence-enhanced tomography
- </strong>
- <br>
- Optics Express, vol. 12, pp. 5402-5417, 2004
- </li>
-
- <li> A. Joshi, A. B. Thompson, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, E. Sevick-Muraca
- <br>
- <strong>Adaptive finite element methods for forward modeling
- in fluorescence enhanced frequency domain optical tomography
- </strong>
- <br>
- Proceedings of the 2004 OSA Biomedical Topical Meetings, 2004
- </li>
-
- <li> A. Joshi, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, A. B. Thompson, E. Sevick-Muraca
- <br>
- <strong>Adaptive finite element methods for fluorescence
- enhanced frequency domain optical tomography: Forward imaging
- problem
- </strong>
- <br>
- Proceedings of the 2004 IEEE International Symposium on
- Biomedical Imaging, 2004
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>Multi-level methods for discontinuous Galerkin FEM on locally refined meshes</strong>
- <br>
- Comput. & Struct., vol. 82, pp. 2437-2445, 2004
- </li>
-
- <li> J. Ramirez, M. Laso
- <br>
- <strong>Micro-macro simulations of three-dimensional plane
- contraction flow
- </strong>
- <br>
- Modelling Simul. Mater. Sci. Eng., vol. 12, pp. 1293-1306, 2004
- </li>
-
- <li> R. B.
- Schulz, <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, J. Peter, W. Semmler
- <br>
- <strong>Independent modeling of
- fluorescence excitation and emission with the finite element method
- </strong>
- <br>
- Proceedings
- of the OSA BIOMED topical meeting, Miami, Florida, 14-18 April 2004
- </li>
-
- <li> E. Zander, J. R. Weimar, H. G. Mathies
- <br>
- <strong>Simulation of High-Frequency Atmospheric Gas Discharges
- </strong>
- <br>
- PAMM, vol. 4, pp. 428-429, 2004
- </li>
-
- </ol>
-
-
-
- <a name="2003"> </a>
- <h2>Publications in 2003</h2>
-
- <ol>
- <li>
- S. Achatz
- <br>
- <strong>Adaptive finite Dünngitter-Elemente höherer Ordnung
- für elliptische partielle Differentialgleichungen mit variablen
- Koeffizienten
- </strong>
- <br>
- Ph.D. thesis, TU Munich, 2003
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>
- <br>
- <strong> Starting threads in a C++ compatible fashion
- </strong>
- <br>
- C/C++ Users Journal, October 2003, pp. 21-24
- </li>
-
- <li> <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, R. Rannacher
- <br>
- <strong>Adaptive Finite Element Methods for Solving Differential Equations
- </strong>
- <br>
- Book, Birkhäuser, 2003
- </li>
-
- <li> M. Calhoun-Lopez
- <br>
- <strong>Numerical solutions of hyperbolic conservation laws:
- Incorporating multi-resolution viscosity methods into the
- finite element framework
- </strong>
- <br>
- Ph.D. thesis, Iowa State University, 2003
- </li>
-
- <li> B. Carnes
- <br>
- <strong>Adaptive finite elements for nonlinear transport equations
- </strong>
- <br>
- Ph.D. thesis, ICES, The University of Texas at Austin, 2003
- </li>
-
- <li>
- B. Cockburn,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>,
- <a href="http://www.math.ubc.ca/~schoetzau/" target="_top">D. Schötzau</a>
- <br>
- <strong>LDG methods for Stokes flow problems</strong>
- <br>
- in Brezzi, Buffa, Corsaro, Murli: Numerical Mathematics and Advanced Applications:
- ENUMATH 2001, Springer Italia, 2003
- </li>
-
- <li>
- B. Cockburn,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>,
- <a href="http://www.math.ubc.ca/~schoetzau/" target="_top">D. Schötzau</a>
- <br>
- <strong>The Local Discontinuous Galerkin Method for the Oseen Equations</strong>
- <br>
- Math. Comput., vol. 73, pp. 569-593, 2003
- </li>
-
- <li>
- J. Gopalakrishnan,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>Application of unified DG analysis to preconditioning DG methods
- </strong>
- <br>
- in Bathe: Computational Fluid and Solid Mechanics, pp. 1943-1945, 2003
- </li>
-
- <li>
- J. Gopalakrishnan,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong> A Multilevel Discontinuous Galerkin Method
- </strong>
- <br>
- Numer. Math., vol. 95, pp. 527-550, 2003
- </li>
-
- <li>
- Jay Gopalakrishnan, <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>Multi-level Preconditioners for the interior penalty method</strong>
- <br>
- in Brezzi, Buffa, Corsaro, Murli: Numerical Mathematics and Advanced Applications:
- ENUMATH 2001, Springer Italia, 2003
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>, P. Houston
- <br>
- <strong> Goal-Oriented A Posteriori Error Estimation
- for Multiple Target Functionals
- </strong>
- <br>
- in T. Y. Hou and E. Tadmor, editors, Hyperbolic Problems:
- Theory, Numerics, Applications, pp. 579-588, Springer, 2003
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>, P. Houston
- <br>
- <strong>Goal-Oriented A Posteriori Error Estimation for Compressible Fluid Flows
- </strong>
- <br>
- In F. Brezzi, A. Buffa, S. Corsaro and A. Murli, editors,
- Numerical Mathematics and Advanced Applications, pp. 775-784, Springer, 2003
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>Discontinuous Galerkin Finite Element Methods for Advection-Diffusion Problems</strong>
- <br>
- Habilitationsschrift, Universität Heidelberg, 2003
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>Preconditioning discontinuous Galerkin saddle point systems</strong>
- <br>
- in Bathe: Computational Fluid and Solid Mechanics, pp. 2016-2018, 2003
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong>Preconditioning methods for local discontinuous {G}alerkin Discretizations</strong>
- <br>
- SIAM J. Sci. Comput., vol. 25, pp. 815-831, 2003
- </li>
-
-
- <li> <a
- href="http://www.math.unibas.ch/~schneeba/" target="_top">A.
- Schneebeli</a>, <a
- href="http://www.math.ubc.ca/~schoetzau/" target="_top">D.
- Schötzau</a>
- <br>
- <strong>Mixed finite elements for incompressible magneto-hydrodynamics
- </strong>
- <br>
- Comptes Rendus Mathematique, vol. 337, pp. 71-74, 2003
- </li>
-
- <li> M. Stadler, G. A. Holzapfel, J. Korelc
- <br>
- <strong>C<sup>n</sup> continuous modelling of smooth contact surfaces
- using NURBS and application to 2D problems
- </strong>
- <br>
- International Journal for Numerical Methods in Engineering,
- vol. 57, pp. 2177-2203, 2003
- </li>
-
- </ol>
-
-
- <a name="2002"> </a>
- <h2>Publications in 2002</h2>
-
- <ol>
-
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>
- <br>
- <strong> Adaptive Finite Element Methods for the
- Identification of Distributed Parameters in
- Partial Differential Equations
- </strong>
- <br>
- Ph.D. thesis, University of Heidelberg, 2002
- </li>
-
- <li> S. Benkler
- <br>
- <strong>Numerical solution of the nonlinear Hartree equation.
- </strong>
- <br>
- Diploma thesis, ETH Zurich, Switzerland, 2002.
- </li>
-
- <li>
- B. Cockburn,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>, <a
- href="http://www.math.ubc.ca/~schoetzau/">D.
- Schötzau</a>
- <br>
- <strong> The local discontinuous Galerkin method in
- incompressible fluid flow
- </strong>
- <br>
- in Mang, Rammerstorfer, Eberhardsteiner: Proceedings of the
- Fifth World Congress on Computational Mechanics (WCCM V),
- Vienna University of Technology, 2002
- </li>
-
- <li>
- B. Cockburn,
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>, <a
- href="http://www.math.ubc.ca/~schoetzau/">D.
- Schötzau</a>, C. Schwab
- <br>
- <strong> Local discontinuous Galerkin methods for the Stokes
- system
- </strong>
- <br>
- SIAM J. Numer. Anal., vol. 40, pp. 319-343, 2002
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>
- <br>
- <strong> Adaptive Finite Element Methods for the Compressible
- Euler Equations
- </strong>
- <br>
- Ph.D. thesis, University of Heidelberg, 2002
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann/"
- target="_top">R. Hartmann</a>, P. Houston
- <br>
- <strong>Adaptive Discontinuous Galerkin Finite Element
- Methods for the Compressible Euler Equations
- </strong>
- <br>
- J. Comput. Phys., vol. 183, pp. 508-532, 2002.
- </li>
-
- <li>
- <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>, P. Houston
- <br>
- <strong>Adaptive Discontinuous Galerkin Finite Element
- Methods for Nonlinear Hyperbolic Conservation Laws
- </strong>
- <br>
- SIAM J. Sci. Comput., vol. 24, pp. 979-1004, 2002.
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>, Rolf Rannacher
- <br>
- <strong> Local error analysis of the interior penalty
- discontinuous Galerkin method for second order elliptic problems
- </strong>
- <br>
- J. Numer. Math., vol. 10, pp. 249-274, 2002
- </li>
-
- <li> F. Mohamed, M. Troyer, G. Blatter
- <br>
- <strong>Interaction of vortices in superconductors with
- kappa close to 1/sqrt(2),
- </strong>
- <br>
- Phys. Rev. B, vol. 65, article 224504, 2002.
- </li>
-
-
- <li> T. Shardlow
- <br>
- <strong>A coupled Cahn-Hilliard particle system
- </strong>
- <br>
- Electronic Journal of Differential Equations,
- vol. 2002, No. 73, pp. 1-21, 2002
- </li>
-
-
- <li> M. Stadler, G. A. Holzapfel
- <br>
- <strong>A novel approach for smooth contact surfaces using NURBS:
- application to the FE simulation of stenting
- </strong>
- <br>
- Proceedings of the 13th Conference of the European Society of
- Biomechanics, 1-4 September 2002, Wroclaw, Poland.
- </li>
-
- </ol>
-
-
-
- <a name="2001"> </a>
- <h2>Publications in 2001</h2>
-
- <ol>
- <li> A. Barinka, T. Barsch, P. Charton, A. Cohen, S. Dahlke,
- W. Dahmen, K. Urban
- <br>
- <strong>Adaptive wavelet schemes for elliptic
- problems—implementation and numerical experiments
- </strong>
- <br>
- SIAM J. Sci. Comput.,
- vol. 23, pp. 910-939, 2001
- </li>
-
- <li>
- B. Cockburn, <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>, Ilaria Perugia, <a
- href="http://www.math.ubc.ca/~schoetzau/">D.
- Schötzau</a>
- <br>
- <strong>Superconvergence of the Local Discontinuous Galerkin
- Method for Elliptic Problems on Cartesian Grids
- </strong>
- <br>
- SIAM J. Numer. Anal. 39 (1), pp. 264-285, 2001
- </li>
-
- <li>
- T. Richter
- <br>
- <strong>Funktionalorientierte Gitteroptimierung bei der Finite-Elemente
- Approximation elliptischer Differentialgleichungen
- </strong>
- <br>
- Diploma thesis, University of Heidelberg, 2001 (in German)
- </li>
- </ol>
-
-
- <a name="2000"> </a>
- <h2>Publications in 2000</h2>
-
- <ol>
-
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>
- <br>
- <strong> Mesh Adaptivity and Error Control for a Finite Element
- Approximation of the Elastic Wave
- Equation
- </strong>
- <br>
- Proceedings of the Waves2000 conference,
- held in Santiago de Compostela, Spain, July 10-14, 2000
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>
- <br>
- <strong> Multi-threading support in deal.II
- </strong>
- <br>
- Preprint 2000-11 (SFB 359), IWR Heidelberg, October 1999.
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>
- <br>
- <strong> Using Modern Features of C++ for Adaptive Finite
- Element Methods:
- Dimension-Independent Programming in deal.II
- </strong>
- <br>
- Proceedings of the 16th IMACS World
- Congress, Lausanne, Switzerland, 2000
- </li>
-
- <li> <a href="http://ganymed.iwr.uni-heidelberg.de/~hartmann"
- target="_top">R. Hartmann</a>
- <br>
- <strong> Adaptive FE-Methods for Conservation Equations
- </strong>
- <br>
- In Heinrich Freistühler and Gerald Warnecke, eds.
- Hyperbolic problems: theory, numerics, applications:
- eighth international conference in Magdeburg, 2000.
- <br>
- International series of numerical mathematics 141: 495-503.
- Birkhäuser, Basel 2001.
- </li>
-
- <li> F. Mohamed
- <br>
- <strong>Interaction of vortices in superconductors with
- kappa close to 1/sqrt(2),
- </strong>
- <br>
- Diploma thesis, ETH Zurich, 2000.
- </li>
-
- </ol>
-
-
-
- <a name="1999"> </a>
- <h2>Publications in 1999</h2>
-
- <ol>
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a> and
- <a href="http://www.math.tamu.edu/~kanschat"
- target="_top">G. Kanschat</a>
- <br>
- <strong> Concepts for object-oriented finite element
- software - the <CODE>deal.II</CODE> library
- </strong>
- <br>
- Preprint 99-43 (SFB 359), IWR Heidelberg, October 1999.
- </li>
-
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, R. Rannacher
- <br>
- <strong> Adaptive finite element approximation of the acoustic wave
- equation: Error estimation and mesh adaptation
- </strong>
- <br>
- East-West Journal of Numerical Mathematics, vol. 7, no. 4 (1999),
- pp. 263-282
- </li>
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>, R. Rannacher
- <br>
- <strong> Adaptive finite element techniques for the acoustic
- wave equation
- </strong>
- <br>
- Journal of Computational Acoustics, vol. 9, no. 2
- (2001), pp. 575-591
- </li>
-
- <li>
- S. Nauber
- <br>
- <strong> Adaptive Finite Elemente Verfahren für
- selbstadjungierte Eigenwertprobleme
- </strong>
- <br>
- Diploma thesis, University of Heidelberg, 1999 (in German)
- </li>
-
- </ol>
-
-
-
-
-
-
-
- <a name="1998"> </a>
- <h2>Publications in 1998</h2>
-
- <ol>
- <li>
- <a href="http://www.math.tamu.edu/~bangerth"
- target="_top">W. Bangerth</a>
- <br>
- <strong> Adaptive Finite-Elemente-Methoden zur Lösung der
- Wellengleichung mit Anwendung in der Physik der Sonne
- </strong>
- <br>
- Diploma thesis, University of Heidelberg, 1998 (in German)
- </li>
- </ol>
-
- <hr />
- <address>
- <a href="../authors.html" target="body">The deal.II Authors</a>
- </address>
- <div class="right">
- <a href="http://validator.w3.org/check?uri=referer" target="_top">
- <img style="border:0" src="http://www.w3.org/Icons/valid-html401" alt="Valid HTML 4.01!"></a>
- <a href="http://jigsaw.w3.org/css-validator/check/referer" target="_top">
- <img style="border:0;width:88px;height:31px" src="http://jigsaw.w3.org/css-validator/images/vcss" alt="Valid CSS!"></a>
- </div>
</body>
</html>