Code Monkey home page Code Monkey logo

publication-list's Introduction

regression-tester/current regression-tester/previous performance-tester/current jenkins/dealii-serial jenkins/dealii-mpi jenkins/dealii-osx jenkins/dealii-ampere workflows/github-docker workflows/indent workflows/tidy workflows/github-linux workflows/github-OSX workflows/github-windows

What is deal.II?

deal.II is a C++ program library targeted at the computational solution of partial differential equations using adaptive finite elements. It uses state-of-the-art programming techniques to offer you a modern interface to the complex data structures and algorithms required.

For the impatient:

Let's say you've unpacked the .tar.gz file into a directory /path/to/dealii/sources. Then configure, compile, and install the deal.II library with:

$ mkdir build
$ cd build
$ cmake -DCMAKE_INSTALL_PREFIX=/path/where/dealii/should/be/installed/to /path/to/dealii/sources
$ make install    (alternatively $ make -j<N> install)
$ make test

To build from the repository, execute the following commands first:

$ git clone https://github.com/dealii/dealii
$ cd dealii

Then continue as before.

A detailed ReadME can be found at ./doc/readme.html, ./doc/users/cmake_user.html, or at https://www.dealii.org/.

Getting started:

The tutorial steps are located under examples/ of the installation. Information about the tutorial steps can be found at ./doc/doxygen/tutorial/index.html or at https://www.dealii.org/.

deal.II includes support for pretty-printing deal.II objects inside GDB. See contrib/utilities/dotgdbinit.py or the new documentation page (under 'information for users') for instructions on how to set this up.

License:

Please see the file ./LICENSE.md for details

Further information:

For further information have a look at ./doc/index.html or at https://www.dealii.org.

Docker Images:

Docker images based on the Ubuntu operating system are available on Docker Hub. You can use any of the available version (list of available tags) by running, for example:

$ docker run --rm -t -i dealii/dealii:master-focal

The above command would drop you into an isolated environment, in which you will find the latest version of deal.II (master development branch) installed under /usr/local.

publication-list's People

Contributors

agrayver avatar bangerth avatar blaisb avatar davydden avatar dklong-csu avatar drwells avatar genevaporter avatar giuseppeorlando878776 avatar iudexaxiom avatar jppelteret avatar juleoc02 avatar katharinajerg avatar kbzowski avatar kronbichler avatar lorenc1o avatar luca-heltai avatar manaswineeb avatar marcfehling avatar masterleinad avatar mathmerizing avatar nfehn avatar peterrum avatar rombur avatar simonsticko avatar tamiko avatar tayloris avatar tjhei avatar tommeswick avatar vovannikov avatar zjiaqi2018 avatar

Stargazers

 avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar

Watchers

 avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar

publication-list's Issues

Sort entries in `bib` files.

biber offers the option to sort all entries in bib files (see 3.1.7 in biber doc).

Although this brings no potential benefit for publication lists of previous years, I think this would be quite useful for the current year and upcoming ones. It would be a lot easier to find duplicate entries early if we sort by author for example.

I can also imagine including a check like indent from the main repository: We can check if the sorted bib file differs from the one in a PR, and request the author to change it. It is also not difficult to add a sort target to the makefile.

The check in #388 is a good first step to find duplicates. However, it only covers duplicate bibtex keys. With a sorted publication list, it would be easier to find real duplicates.

What do you think? I am confident that I can prepare a patch in a few minutes :)

Another one

A Comparison of the Explicit and Implicit Hybridizable Discontinuous Galerkin Methods for Nonlinear Shallow Water Equations
July 2019 Journal of Scientific Computing
DOI: 10.1007/s10915-019-01007-z
Ali Samii Kazbek Kazhyken Craig Michoski Clint Dawson

Also this one

https://www.researchgate.net/publication/320280058_Fluid-Structure_Interaction_with_the_Entropic_Lattice_Boltzmann_Method

Physical review. E, Statistical physics, plasmas, fluids, and related interdisciplinary topics 97(2):023305
DOI: 10.1103/PhysRevE.97.023305

@article{Dorschner2018,
  doi = {10.1103/physreve.97.023305},
  url = {https://doi.org/10.1103/physreve.97.023305},
  year = {2018},
  month = feb,
  publisher = {American Physical Society ({APS})},
  volume = {97},
  number = {2},
  author = {B. Dorschner and S. S. Chikatamarla and I. V. Karlin},
  title = {Fluid-structure interaction with the entropic lattice Boltzmann method},
  journal = {Physical Review E}
}

Update @misc formatting

The @misc entries introduced in #133 come out funny on https://dealii.org/publications.html -- just search for "second order ensemble" for example. That's unfortunate, because #133 uses exactly the form for the bibtex entry that is produced by arXiv. We should just update the entry that parses @misc entries and that is called by jabref.

Add another two

From the mailing list:

@mastersthesis{2018,
  author    = {Schneider, David},
  title     = {Simulation von Fluid-Struktur-Interaktion mit der Kopplungsbibliothek preCICE},
  school    = {Universität Siegen},
  year      = {2018},
  note      = {Bachelorarbeit}
}
@mastersthesis{2017,
  author    = {Rave, Kevin},
  title     = {Kopplung von OpenFOAM und deal.II Gleichungslösern mit preCICE zur Simulation multiphysikalischer Probleme},
  school    = {Universität Siegen},
  year      = {2017}
}

Add publications by Mustafa Ağgül

By email, I received the following list of publications not currently on the website but that use deal.II:

Missing Publications

  1. M. Aggul, F. G. Eroglu, S. Kaya, A. Labovsky, A projection based variational multiscale method for a fluid-fluid interaction problem, Computer Methods in Applied Mechanics and Engineering, vol.365, 112957, 2020.
    https://doi.org/10.1016/j.cma.2020.112957
  2. M. Aggul, S. Kaya, Defect-Deferred Correction Method Based on a Subgrid Artificial Viscosity Modeling for Fluid-Fluid Interaction, Applied Numerical Mathematics, vol.160, 178-191, 2021.
    https://doi.org/10.1016/j.apnum.2020.10.004
  3. M. Aggul, Defect Deferred Correction Method Based on a Subgrid Artificial Viscosity Modeling, Journal of Mathematical Analysis and Applications, vol.497(2), 124878, 2021.
    https://doi.org/10.1016/j.apnum.2020.10.004
  4. M. Aggul, A Grad-Div Stabilized Penalty Projection Algorithm for Fluid-Fluid Interaction Problem, Applied Mathematics and Computation, vol.414, 126670, 2022.
    https://doi.org/10.1016/j.amc.2021.126670
  5. M. Aggul, A. Labovsky, Approximate Deconvolution Models for a Fluid-Fluid Interaction Problem with High Reynolds Numbers, Computers & Mathematics with Applications, vol.117, 113-126, 2022.
    https://doi.org/10.1016/j.camwa.2022.04.011
  6. M. Aggul, F. G. Eroglu, S. Kaya, Artificial Compression Method for MHD System in Elsässer Variables, Applied Numerical Mathematics, 185: 72-87, 2022.
    https://doi.org/10.1016/j.apnum.2022.11.009
  7. M. Aggul, A. Labovsky, E. Onal, K. Schwiebert, Fluid-Fluid Interaction Problems at High Reynolds Numbers: Reducing the Modeling Error with LES-C, SIAM Journal on Numerical Analysis, vol.61, iss.2, pp. 707-732, 2023.
    https://doi.org/10.1137/22M1494269
  8. M. Aggul, A. B. Cibik, Fatma G. Eroglu, S. Kaya, Deferred Correction Method for the Continuous Data Assimilation Model, Computer Methods in Applied Mechanics, and Engineering, vol.415, 116259, 2023.
    https://doi.org/10.1016/j.cma.2023.116259

Missing Thesis

A High Accuracy Minimally Invasive Regularization Technique for Navier-Stokes Equations at High Reynolds Numbers, Michigan Tech, 2016.

Fix problems in the bibtex files

@ljhwang ran our database through a script and found a number of problems with the entries. The lines numbers are wrong because I gave her a collated file, but the errors should probably still be fixed:

ignoring entry '2011_11' (line 3272) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2011_38' (line 3550) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2012_6' (line 3895) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2012_11' (line 3945) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2012_12' (line 3957) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2012_29' (line 4134) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2013_65' (line 5283) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2013_66' (line 5295) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2015_88' (line 7919) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2016_113' (line 9793) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2017_46' (line 11267) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2017_50' (line 11309) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2017_69' (line 11512) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2017_89' (line 11717) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2018_3' (line 12081) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2018_4' (line 12093) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2018_27' (line 12349) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry '2018_40' (line 12493) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

ignoring entry 'RMCGG19' (line 13055) because :
	A bibentry of bibtype ‘Article’ has to specify the field: journal

Bugs in jabref.

I noticed two issues when looking for E. Bängtsson, B. Lund on https://www.dealii.org/publications.html
image

  1. Why is the 2006 entry listed as Thesis although it is a @TechReport?
    @TechReport{bangtsson.lund:comparison,
    author = {E. B\"{a}ngtsson and B. Lund},
    title = {A comparison between two approaches to solve the equations of isostasy},
    year = 2006,
    institution = {Institute for Parallel Processing},
    address = {Bulgarian Academy of Sciences},
    series = {BIS-21++ Report},
    number = {2006-03},
    url = {http://bis-21pp.acad.bg/private/EricB-TRreport-final.pdf}
    }
  2. When clicking on the BibTeX button of the 2006 entry, the BibTeX entry for the 2008 publication expands. They both share the same citekey bangtsson.lund:comparison now since the introduction of bibtool, which is most likely the case for this behavior. This bug has been around before bibtool, but remained hidden until now. A quick fix is to also add the year into the citekey. I'm working on a fix right now.

Check before adding to 2022 publications

There are three entries for the 2022 list that we did not have access to, so we couldn't check if they actually use deal.II or not.

If any of you can verify that these articles use deal.II, feel free to add them to the list.

  • [ ] pending (EDIT: To me it looks like they are using p4est only. They mention deal.II as we interface with p4est.)
@article{Yang2022,
  title = {An Immersed Boundary Method Based on Parallel Adaptive Cartesian Grids for High Reynolds Number Turbulent Flow},
  volume = {36},
  ISSN = {1029-0257},
  url = {https://doi.org/10.1080/10618562.2022.2108807},
  DOI = {10.1080/10618562.2022.2108807},
  number = 4,
  journal = {International Journal of Computational Fluid Dynamics},
  publisher = {Taylor \& Francis},
  author = {Yang, Yuchen and Qi, Xinyu and Wang, Zhenming and Liu, Jianming and Zhao, Ning},
  year = 2022,
  month = apr,
  pages = {319--341}
}
  • pending, probably doesn't use deal.II as they refer to a software package called CODA
@inproceedings{Lowe2022,
  title = {hp-Adaptation for a Discontinuous Galerkin Method in an Unstructured Flow Solver},
  url = {https://doi.org/10.2514/6.2022-1372},
  DOI = {10.2514/6.2022-1372},
  booktitle = {AIAA SCITECH 2022 Forum},
  publisher = {American Institute of Aeronautics and Astronautics},
  author = {L\"{o}we, Johannes and Orlt, Matthias},
  year = {2022},
  month = jan 
}
  • #585 (EDIT: uses deal.II)
@article{vanDuijn2022,
  title = {Mandel’s problem as a benchmark for two-dimensional nonlinear poroelasticity},
  volume = 101,
  ISSN = {1563-504X},
  url = {https://doi.org/10.1080/00036811.2022.2091992},
  DOI = {10.1080/00036811.2022.2091992},
  number = 12,
  journal = {Applicable Analysis},
  publisher = {Taylor \& Francis},
  author = {van Duijn, C. J. and Mikeli\'c, A. and Wick, T.},
  year = 2022,
  month = jun,
  pages = {4267--4293}
}

More publications

Here are some more that were emailed to me:

2019
S. Rudraraju, D.E. Moulton, R. Chirat, A. Goriely, K. Garikipati, A computational framework for the morpho-elastic development of molluskan shells by surface and volume growth'', (under review)[arXiv] J. Jiang, K. Garikipati, S. RudrarajuA diffuse interface framework for modelling the evolution of multi-cell aggregates as a soft packing problem due to growth and division of cells'', Bulletin of Mathematical Biology , 2019. [journal][arXiv]

2018
LK. Aagesen et al., ``PRISMS: An Integrated, Open-Source Framework for Accelerating Predictive Structural Materials Science'', The Journal of The Minerals, Metals & Materials Society (JOM) , Vol. 70, 2298-2314, 2018. [journal]

2017
S DeWitt et al., ``Misfit-driven β''' precipitate composition and morphology in Mg-Nd alloys'', Acta Materialia, Vol. 136, 378-389, 2017. [journal]

2016
S. Rudraraju, A van der Ven, K. Garikipati, Mechano-chemical spinodal decomposition: A phenomenological theory of phase transformations in multi-component, crystalline solids'', Nature Computational Materials, 2016, doi:10.1038/npjcompumats.2016.12. [journal] [arXiv] Z. Wang, S. Rudraraju, K. Garikipati, A three dimensional field formulation, and isogeometric solutions to point and line defects using Toupin's theory of gradient elasticity at finite strains'', Journal of the Mechanics and Physics of Solids (JMPS), Vol. 94: 336-361, 2016, doi:10.1016/j.jmps.2016.03.028.[journal] [arXiv]

warnings

Package biblatex Warning: Biber reported the following issues
(biblatex)                with '2007_11':
(biblatex)                - Name in key '2007_11' is empty (probably consecutiv
e 'and'): skipping name.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with '2009_9':
(biblatex)                - Name in key '2009_9' is empty (probably consecutive
 'and'): skipping name.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with '2009_48':
(biblatex)                - Name in key '2009_48' is empty (probably consecutiv
e 'and'): skipping name.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with '2014_50':
(biblatex)                - Name in key '2014_50' is empty (probably consecutiv
e 'and'): skipping name.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with '2016_3':
(biblatex)                - Name in key '2016_3' is empty (probably consecutive
 'and'): skipping name.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with '2016_45':
(biblatex)                - Name in key '2016_45' is empty (probably consecutiv
e 'and'): skipping name.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with 'Giuliani2016':
(biblatex)                - Overwriting field 'year' with year value from field
 'date' for entry 'Giuliani2016'.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with 'Giuliani2016':
(biblatex)                - Overwriting field 'month' with month value from fie
ld 'date' for entry 'Giuliani2016'.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with '2016_71':
(biblatex)                - Name in key '2016_71' is empty (probably consecutiv
e 'and'): skipping name.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with '2016_83':
(biblatex)                - Name in key '2016_83' is empty (probably consecutiv
e 'and'): skipping name.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with 'Peterson':
(biblatex)                - Overwriting field 'year' with year value from field
 'date' for entry 'Peterson'.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with 'Peterson':
(biblatex)                - Overwriting field 'month' with month value from fie
ld 'date' for entry 'Peterson'.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with 'Zhenga':
(biblatex)                - Overwriting field 'year' with year value from field
 'date' for entry 'Zhenga'.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with 'Zhenga':
(biblatex)                - Overwriting field 'month' with month value from fie
ld 'date' for entry 'Zhenga'.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with '2017_4':
(biblatex)                - Name in key '2017_4' is empty (probably consecutive
 'and'): skipping name.


Package biblatex Warning: Biber reported the following issues
(biblatex)                with '2017_84':
(biblatex)                - Name in key '2017_84' is empty (probably consecutiv
e 'and'): skipping name.

Agros Suite

I've found the "Agros Suite", which is using deal.II and Hermes as third party libraries.

As they are using the library, we should also put (part of) their work into the publication list. We need to check their publications and filter in which they use/refer to deal.II

http://www.agros2d.org/
http://www.agros2d.org/about/

Looks like they've been using it since 2014:
artap-framework/agrossuite@06a1e63
https://github.com/search?p=2&q=repo%3Aartap-framework%2Fagrossuite+deal.II&type=Commits

additional 2018 entries

before adding these:

  1. check that they are valid papers that use deal.II
  2. check that they are not already in the .bib files.
  3. fix up the publication
@Article{Schutz2018,
  author = {Sch{\"{u}}tz, SS},
  title  = {{3D Boundary Element Simulation of Droplet Dynamics in Microchannels: How Droplets Squeeze Through Constrictions and Move in Electric Fields}},
  year   = {2018},
  file   = {:home/heister/.local/share/data/Mendeley Ltd./Mendeley Desktop/Downloaded/Sch{\"{u}}tz - 2018 - 3D Boundary Element Simulation of Droplet Dynamics in Microchannels How Droplets Squeeze Through Constrictions and Move.pdf:pdf},
  url    = {https://infoscience.epfl.ch/record/255307},
}

@Article{Koepf,
  author  = {Koepf, JA and Soldner, D and Gotterbarm, MR and Markl, M},
  title   = {{3D Grainstructure simulation in powder bed additive manufacturing}},
  journal = {researchgate.net},
  file    = {:home/heister/.local/share/data/Mendeley Ltd./Mendeley Desktop/Downloaded/Koepf et al. - Unknown - 3D Grainstructure simulation in powder bed additive manufacturing.pdf:pdf},
  url     = {https://www.researchgate.net/profile/Johannes{\_}Koepf2/publication/325194334{\_}3D{\_}Grainstructure{\_}simulation{\_}in{\_}powder{\_}bed{\_}additive{\_}manufacturing/links/5afd3b52458515e9a59b1dd1/3D-Grainstructure-simulation-in-powder-bed-additive-manufacturing.pdf},
}

@Article{SACCO2018,
  author = {SACCO, FGD},
  title  = {{A 3D adaptive boundary element method for potential flow with nonlinear Kutta condition}},
  year   = {2018},
  file   = {:home/heister/.local/share/data/Mendeley Ltd./Mendeley Desktop/Downloaded/SACCO - 2018 - A 3D adaptive boundary element method for potential flow with nonlinear Kutta condition.pdf:pdf},
  url    = {https://www.politesi.polimi.it/handle/10589/140106},
}

@Article{Arndt,
  author        = {Arndt, Daniel and Kanschat, Guido},
  title         = {{A C1-mapping based on finite elements on quadrilateral and hexahedral meshes}},
  journal       = {arxiv.org},
  year          = {2018},
  month         = {oct},
  abstract      = {Finite elements of higher continuity, say conforming in {\$}H{\^{}}2{\$} instead of {\$}H{\^{}}1{\$}, require a mapping from reference cells to mesh cells which is continuously differentiable across cell interfaces. In this article, we propose an algorithm to obtain such mappings given a topologically regular mesh in the standard format of vertex coordinates and a description of the boundary. A variant of the algorithm with orthogonal edges in each vertex is proposed. We introduce necessary modifications in the case of adaptive mesh refinement with nonconforming edges. Furthermore, we discuss efficient storage of the necessary data.},
  archiveprefix = {arXiv},
  arxivid       = {1810.02473},
  eprint        = {1810.02473},
  file          = {:home/heister/.local/share/data/Mendeley Ltd./Mendeley Desktop/Downloaded/Arndt, Kanschat - 2018 - A C1-mapping based on finite elements on quadrilateral and hexahedral meshes.pdf:pdf},
  url           = {https://arxiv.org/abs/1810.02473},
}

@Article{Boffi,
  author  = {Boffi, D and Gastaldi, L and of The, L Heltai - Mathematical and Numerical Modeling and undefined 2018},
  title   = {{A distributed lagrange formulation of the finite element immersed boundary method for fluids interacting with compressible solids}},
  journal = {Springer},
  year    = {2018},
  pages   = {1--21},
  doi     = {10.1007/978-3-319-96649-6_1},
  file    = {:home/heister/.local/share/data/Mendeley Ltd./Mendeley Desktop/Downloaded/Boffi et al. - Unknown - A distributed lagrange formulation of the finite element immersed boundary method for fluids interacting with c.pdf:pdf},
  url     = {https://link.springer.com/chapter/10.1007/978-3-319-96649-6{\_}1},
}

@Article{Kronbichler,
  author  = {Kronbichler, M and of {\ldots}, A Diagne - {\ldots} International Journal and undefined 2018},
  title   = {{A fast massively parallel two-phase flow solver for microfluidic chip simulation}},
  journal = {journals.sagepub.com},
  year    = {2018},
  volume  = {32},
  number  = {2},
  pages   = {266--287},
  month   = {mar},
  issn    = {1094-3420},
  doi     = {10.1177/1094342016671790},
  file    = {:home/heister/.local/share/data/Mendeley Ltd./Mendeley Desktop/Downloaded/Kronbichler, Diagne, Holmgren - 2018 - A fast massively parallel two-phase flow solver for microfluidic chip simulation.pdf:pdf},
  url     = {https://journals.sagepub.com/doi/abs/10.1177/1094342016671790},
}

Check before adding to 2021 publications

There are three entries for the 2021 list that we did not have access to, so we couldn't check if they actually use deal.II or not. I've asked for their full-text on researchgate.

If any of you can verify that these articles use deal.II, feel free to add them to the list.

@Article{friedlein.mergheim.ea:finite,
  author  = {J Friedlein and J Mergheim and P Steinmann},
  title   = {A finite plasticity gradient-damage model for sheet metals during forming and clinching},
  journal = {Trans Tech Publ},
  url     = {https://www.scientific.net/KEM.883.57}
}
@Article{schuh-senlis.cedric.ea:structural,
  author  = {M. Schuh-Senlis and T. Cedric and C. Paul and C. Guillaume},
  doi     = {10.3997/2214-4609.202010733},
  isbn    = {9781713841449},
  journal = {82nd EAGE Conference and Exhibition 2021},
  pages   = {802-806},
  publisher = {European Association of Geoscientists and Engineers, EAGE},
  title   = {STRUCTURAL RESTORATION OF GEOLOGICAL STRUCTURES WITH VISCOUS STOKES FLOW - PRINCIPLE AND FIRST RESULTS},
  volume  = {2},
  year    = {2021}
}
  • pending
@Article{shi-dong.nadarajah:newton-krylov,
  author  = {Doug Shi-Dong and Siva Nadarajah},
  title   = {Newton-krylov full-space aerodynamic shape optimization},
  journal = {AIAA Scitech 2021 Forum},
  year    = {2021},
  pages   = {1-9},
  doi     = {10.2514/6.2021-0281},
  isbn    = {9781624106095},
  publisher = {American Institute of Aeronautics and Astronautics Inc, AIAA}
}

broken formatting

these entries are formatted incorrectly starting with ", " in the second line:
image

@bangerth You know the formatting schema best. Do you know what is happening here?

Add ASPECT publications

I believe that these are not yet in the list (or at least I haven't manually copied them):

@article{Comeau2021,
  doi = {10.1029/2020jb021304},
  url = {https://doi.org/10.1029/2020jb021304},
  year = {2021},
  month = may,
  publisher = {American Geophysical Union ({AGU})},
  volume = {126},
  number = {5},
  author = {Matthew J. Comeau and Claudia Stein and Michael Becken and Ulrich Hansen},
  title = {Geodynamic Modeling of Lithospheric Removal and Surface Deformation: Application to Intraplate Uplift in {C}entral {M}ongolia},
  journal = {Journal of Geophysical Research: Solid Earth}
}

@article{STEIN2022229276,
title = {Numerical study on the style of delamination},
journal = {Tectonophysics},
pages = {229276},
year = {2022},
issn = {0040-1951},
doi = {10.1016/j.tecto.2022.229276},
url = {https://www.sciencedirect.com/science/article/pii/S0040195122000701},
author = {Claudia Stein and Matthew Comeau and Michael Becken and Ulrich Hansen},
keywords = {Numerical modelling delamination, Rayleigh-Taylor instability phase transition rheology},
abstract = {Delamination of the lower crust or lithospheric mantle is one explanation for the surface uplift observed in areas of mountain building. This process describes the removal of the lower part of the tectonic plate and can occur in various ways. Different styles of delamination typically have in common that the upper material (e.g., lowermost crust or lithospheric mantle) is denser than the underlying material (e.g., asthenosphere) and therefore sinks. It has been proposed that the higher density can be caused by the formation of eclogite. In this study we apply a thermomechanical model featuring a density increase within the lithosphere by a phase transition. The model setup is designed to investigate surface uplift and mountain building in an intracontinental setting. Specifically, the model is arranged to closely resemble central Mongolia. The models give insights into the dynamically evolving flow field with respect to the style of removal, therefore the general outcome is also applicable to other orogenic regions. In addition to a systematic study on the phase transition, we also investigate the influence of convergent motion and of the rheology of the crust. Our results reveal that for the absence of a dense (eclogite) layer, delamination initially occurs as a stationary Rayleigh-Taylor instability which appears as a late and short-lived event. In comparison, for a strong density contrast an early, long-lived peeling-off removal style with a stationary slab results. The subsequent asthenospheric upwelling causes further peeling-off events for all density contrasts. For this removal style a retreating slab is observed that occasionally breaks off giving way to a periodic behavior. The findings confirm that a strong convergence and low viscosity of the crust promote delamination. In addition, the asthenospheric upwelling yields a wide and flat surface uplift. Such dome-like features are observed to be more pronounced for high density contrasts (i.e., strong eclogitisation).}
}

@article{https://doi.org/10.1029/2021JB023244,
author = {Zha, Caicai and Lin, Jian and Zhou, Zhiyuan and Xu, Min and Zhang, Xubo},
title = {Effects of Hotspot-Induced Long-Wavelength Mantle Melting Variations on Magmatic Segmentation at the {R}eykjanes Ridge: Insights From 3D Geodynamic Modeling},
journal = {Journal of Geophysical Research: Solid Earth},
volume = {127},
number = {3},
pages = {e2021JB023244},
doi = {10.1029/2021JB023244},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2021JB023244},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2021JB023244},
note = {e2021JB023244 2021JB023244},
year = {2022}
}

@article{https://doi.org/10.1029/2022GL098003,
author = {Heyn, Bj{\"o}rn H. and Conrad, Clinton P.},
title = {On the relation between basal erosion of the lithosphere and surface heat flux for continental plume tracks},
journal = {Geophysical Research Letters},
volume = {49},
number = {7},
year = {2022},
pages = {e2022GL098003},
keywords = {plume-lithosphere interactions, mantle plumes, geothermal heat flux, lithospheric thinning, continental plume tracks, upper mantle viscosity structure},
doi = {10.1029/2022GL098003},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2022GL098003},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2022GL098003},
note = {e2022GL098003 2022GL098003},
abstract = {Abstract While hotspot tracks beneath thin oceanic lithosphere are visible as volcanic island chains, the plume-lithosphere interaction for thick continental or cratonic lithosphere often remains hidden due to the lack of volcanism. To identify plume tracks with missing volcanism, we characterize the amplitude and timing of surface heat flux anomalies following a plume-lithosphere interaction using mantle convection models. Our numerical results confirm an analytical relationship in which surface heat flux increases with the extent of lithosphere thinning, which is primarily controlled by on the viscosity structure of the lower lithosphere and the asthenosphere. We find that lithosphere thinning is greatest when the plate is above the plume conduit, while the maximum heat flux anomaly occurs about 40-140 Myr later. Therefore, younger continental and cratonic plume tracks can be identified by observed lithosphere thinning, and older tracks by an increased surface heat flux, even if they lack extrusive magmatism.}
}

@article{NEGREDO2022117506,
title = {On the origin of the {C}anary {I}slands: {I}nsights from mantle convection modelling},
journal = {Earth and Planetary Science Letters},
volume = {584},
pages = {117506},
year = {2022},
issn = {0012-821X},
doi = {10.1016/j.epsl.2022.117506},
url = {https://www.sciencedirect.com/science/article/pii/S0012821X2200142X},
author = {Ana M. Negredo and Jeroen van Hunen and Juan Rodr{\'{\i}}guez-Gonz{\'{a}}lez and Javier Fullea},
keywords = {Canary Islands, edge-driven convection, hot spots, mantle convection},
abstract = {The Canary Islands hotspot consists of seven volcanic islands, mainly of Neogene age, rooted on oceanic Jurassic lithosphere. Its complex structure and geodynamic setting have led to different hypotheses about its origin and evolution, which is still a matter of a vivid debate. In addition to the classic mantle plume hypothesis, a mechanism of small-scale mantle convection at the edge of cratons (Edge Driven Convection, EDC) has been proposed due to the close proximity of the archipelago to the NW edge of the NW African Craton. A combination of mantle plume upwelling and EDC has also been hypothesized. In this study we evaluate these hypotheses quantitatively by means of numerical two-dimensional thermo-mechanical models. We find that models assuming only EDC require sharp edges of the craton and predict too narrow areas of partial melting. Models where the ascent of an upper-mantle plume is forced result in an asymmetric mantle flow pattern due to the interplay between the plume and the strongly heterogeneous lithosphere. The resulting thermal anomaly in the asthenosphere migrates laterally, in agreement with the overall westward decrease of the age of the islands. We suggest that laterally moving plumes related to strong lithospheric heterogeneities could explain the observed discrepancies between geochronologically estimated hotspot rates and plate velocities for many hotspots.}
}

@article{Behr_2022,
  doi = {10.1093/gji/ggac075},
  url = {https://doi.org/10.1093/gji/ggac075},
  year = 2022,
  month = feb,
  publisher = {Oxford University Press ({OUP})},
  author = {Whitney M. Behr and Adam F. Holt and Thorsten W. Becker and Claudio Faccenna},
  title = {The effects of plate interface rheology on subduction kinematics and dynamics},
  journal = {Geophysical Journal International}
}

@Article{se-13-849-2022,
AUTHOR = {Root, B. C. and Sebera, J. and Szwillus, W. and Thieulot, C. and Martinec, Z. and Fullea, J.},
TITLE = {Benchmark forward gravity schemes: the gravity field of a realistic lithosphere model {WINTERC-G}},
JOURNAL = {Solid Earth},
VOLUME = {13},
YEAR = {2022},
NUMBER = {5},
PAGES = {849--873},
URL = {https://se.copernicus.org/articles/13/849/2022/},
DOI = {10.5194/se-13-849-2022}
}

@MastersThesis{quiroga2022numericalm,
  author = {Quiroga, David},
  school = {University of Alberta},
  title  = {Numerical Models of Lithosphere Removal in the {S}ierra {N}evada de {S}anta {M}arta, {C}olombia},
  year   = {2022},
  pages  = {178},
}

@phdthesis { 2022numericalm,
  author = {Janbakhsh, Payman},
	title = {Numerical Modeling Of Tectonic Plates \& Application of Artificial Neural Networks in Earthquake Seismology},
	school = {University of Toronto},
  url = {https://hdl.handle.net/1807/123260},
	year = {2022}
}

@article{https://doi.org/10.1029/2021GC009808,
author = {Liu, Shangxin and King, Scott D.},
title = {Dynamics of the {N}orth {A}merican Plate: {L}arge-Scale Driving Mechanism From Far-Field Slabs and the Interpretation of Shallow Negative Seismic Anomalies},
journal = {Geochemistry, Geophysics, Geosystems},
volume = {23},
number = {3},
pages = {e2021GC009808},
keywords = {North American plate, far-field slabs, slow seismic velocity, partial melt, plate motions, geoid},
doi = {10.1029/2021GC009808},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2021GC009808},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2021GC009808},
note = {e2021GC009808 2021GC009808},
abstract = {Abstract With a small fraction of marginal subduction zones, the driving mechanism for the North American plate motion is in debate. We construct global mantle flow models simultaneously constrained by geoid and plate motions to investigate the driving forces for the North American plate motion. By comparing the model with only near-field subducting slabs and that with global subducting slabs, we find that the contribution to the motion of the North American plate from the near-field Aleutian, central American, and Caribbean slabs is small. In contrast, other far-field slabs, primarily the major segments around western Pacific subduction margins, provide the dominant large-scale driving forces for the North American plate motion. The coupling between far-field slabs and the North American plate suggests a new form of active plate interactions within the global self-organizing plate tectonic system. We further evaluate the extremely slow seismic velocity anomalies associated with the shallow partial melt around the southwestern North America. Interpreting these negative seismic shear-velocity anomalies as purely thermal origin generates considerably excessive resistance to the North American plate motion. A significantly reduced velocity-to-density scaling for these negative seismic shear-velocity anomalies must be incorporated into the construction of the buoyancy field to predict the North American plate motion. We also examine the importance of lower mantle buoyancy including the ancient descending Kula-Farallon plates and the active upwelling below the Pacific margin of the North American plate. Lower mantle buoyancy primarily affects the amplitudes, as opposed to the patterns of both North American and global plate motions.},
year = {2022}
}

@Article{gmd-15-5127-2022,
AUTHOR = {Davies, D. R. and Kramer, S. C. and Ghelichkhan, S. and Gibson, A.},
TITLE = {Towards automatic finite-element methods for geodynamics via {F}iredrake},
JOURNAL = {Geoscientific Model Development},
VOLUME = {15},
YEAR = {2022},
NUMBER = {13},
PAGES = {5127--5166},
URL = {https://gmd.copernicus.org/articles/15/5127/2022/},
DOI = {10.5194/gmd-15-5127-2022}
}

@article{JINGCHUN2022115197,
title = {On the formation of thrust fault-related landforms in {M}ercury's {N}orthern {S}mooth {P}lains: {A} new mechanical model of the lithosphere},
journal = {Icarus},
pages = {115197},
year = {2022},
issn = {0019-1035},
doi = {10.1016/j.icarus.2022.115197},
url = {https://www.sciencedirect.com/science/article/pii/S0019103522002962},
author = {Xie Jingchun and Huang Chengli and Zhang Mian},
keywords = {Mercury, Thrust fault, Lithospheric model, Formation, Numerical simulations},
abstract = {There are numerous tectonic shortening structures distributed across the planet, Mercury. As Mercury's largest single volcanic deposit, the northern smooth plains (NSP) is dominated by thrust fault-related landforms, showing particularity in their tectonic patterns compared with their counterparts in other geological terrains on Mercury. Geomorphic interpretations of these landforms assume an internal layering lithosphere to account for the deformation accommodating superficial units, implying the deformation in the NSP is thin-rooted dominated. However, the commonly used lithospheric mechanical model is an oversimplification that only allows for the sharp transition from brittle to ductile deformation, failing to explain the thin-rooted deformation well. In this work, we propose a new mechanical model incorporating the semi-brittle deformation in the lithosphere to account for an equivalent weak layer at shallow depth, filling the gap between brittle and ductile deformation. In addition, we implement 2-D numerical simulations to simulate the formation of thrust fault-related landforms in the NSP of 3.8 billion years ago. As a result, we obtain surface topographies roughly consistent with lobate scarps. Our results also support that most thrust fault-related landforms were likely formed over a period with a gradually decreased background compressive strain rate, and these landforms can retain their basic geomorphic features on this planet with little to no erosion. Although the physical properties of semi-brittle deformation are not fully understood, considering such a deformation model in planetary science is still promising, especially when studying the thermodynamic processes of a planet.}
}

@article{FANG2022105350,
title = {The causal mechanism of the {S}angihe Forearc Thrust, {M}olucca {S}ea, northeast {I}ndonesia, from numerical simulation},
journal = {Journal of Asian Earth Sciences},
volume = {237},
pages = {105350},
year = {2022},
issn = {1367-9120},
doi = {10.1016/j.jseaes.2022.105350},
url = {https://www.sciencedirect.com/science/article/pii/S1367912022002814},
author = {Gui Fang and Jian Zhang and Tianyao Hao and Miao Dong and Chenghao Jiang and Yubei He},
keywords = {Forearc collision, Sangihe Arc, Halmahera Arc, Forearc thrusting, Numerical modeling}
}

@Article{Bahadori2022,
  author   = {Bahadori, Alireza and Holt, William E. and Feng, Ran and Austermann, Jacqueline and Loughney, Katharine M. and Salles, Tristan and Moresi, Louis and Beucher, Romain and Lu, Neng and Flesch, Lucy M. and Calvelage, Christopher M. and Rasbury, E. Troy and Davis, Daniel M. and Potochnik, Andre R. and Ward, W. Bruce and Hatton, Kevin and Haq, Saad S. B. and Smiley, Tara M. and Wooton, Kathleen M. and Badgley, Catherine},
  journal  = {Nature Communications},
  title    = {Coupled influence of tectonics, climate, and surface processes on landscape evolution in southwestern North America},
  year     = {2022},
  issn     = {2041-1723},
  month    = aug,
  number   = {1},
  pages    = {4437},
  volume   = {13},
  abstract = {The Cenozoic landscape evolution in southwestern North America is ascribed to crustal isostasy, dynamic topography, or lithosphere tectonics, but their relative contributions remain controversial. Here we reconstruct landscape history since the late Eocene by investigating the interplay between mantle convection, lithosphere dynamics, climate, and surface processes using fully coupled four-dimensional numerical models. Our quantified depth-dependent strain rate and stress history within the lithosphere, under the influence of gravitational collapse and sub-lithospheric mantle flow, show that high gravitational potential energy of a mountain chain relative to a lower Colorado Plateau can explain extension directions and stress magnitudes in the belt of metamorphic core complexes during topographic collapse. Profound lithospheric weakening through heating and partial melting, following slab rollback, promoted this extensional collapse. Landscape evolution guided northeast drainage onto the Colorado Plateau during the late Eocene-late Oligocene, south-southwest drainage reversal during the late Oligocene-middle Miocene, and southwest drainage following the late Miocene.},
  day      = {01},
  doi      = {10.1038/s41467-022-31903-2},
  url      = {https://doi.org/10.1038/s41467-022-31903-2},
}

 @article{GIAMBIAGI2022104138,
 title = {Crustal anatomy and evolution of a subduction-related orogenic system: Insights from the Southern Central Andes (22-35{\textdegree}S)},
 journal = {Earth-Science Reviews},
 pages = {104138},
 year = {2022},
 issn = {0012-8252},
 doi = {10.1016/j.earscirev.2022.104138},
 url = {https://www.sciencedirect.com/science/article/pii/S0012825222002227},
 author={Giambiagi, Laura and Tassara, Andr{\'e}s and Echaurren, Andr{\'e}s and Julve, Joaqu{\'\i}n and Quiroga, Rodrigo and Barrionuevo, Mat{\'\i}as and Liu, Sibiao and Echeverr{\'\i}a, I{\~n}igo and Mard{\'o}nez, Diego and Suriano, Julieta and others},
 keywords = {Central Andes, Mountain building, Subduction orogen, Kinematic forward modeling, Thermomechanical model, Geodynamic modeling, Megadetachment, Orogenic processes},
}


@article{LIU2022105385,
title = {How do pre-existing weak zones and rheological layering of the continental lithosphere influence the development and evolution of intra-continental subduction?},
journal = {Journal of Asian Earth Sciences},
volume = {238},
pages = {105385},
year = {2022},
issn = {1367-9120},
doi = {10.1016/j.jseaes.2022.105385},
url = {https://www.sciencedirect.com/science/article/pii/S1367912022003169},
author = {Mengxue Liu and Dinghui Yang},
keywords = {Intra-continental subduction, 2D numerical modeling, Pre-existing weak zones, Lithospheric rheological strength},
abstract = {Intra-continental subduction is of special importance for studying the formation of intra-continental orogens, crust-mantle structural evolution, and the far-field effects of continental collision, whose mechanism is still a matter of discussion. In this work, we investigated the role of pre-existing weak zones and the continental lithospheric rheological layering in the formation and evolution of the intra-continental subduction based on a 2D finite element numerical technique. The model results indicate that the deeper the intra-continental weak zone is and the faster the convergence velocity is, the more likely it is to develop into a new intra-continental subduction. Altering the rheological strength of the overriding plate may not have a substantial impact on the intra-continental subduction mode when the depth of the pre-existing weak zone is larger than half of the lithospheric thickness. In contrast, the lithospheric rheological strength is closely related to the continental collision system's deformation style: Models with a weaker overriding plate are inclined to delaminate continuously under collision, whereas a strong overriding plate results in the subducting plate's roll-back. The reactivation of the suture that runs deep into the lithosphere as a result of the Indian-Asian continental collision could be one of the crucial factors controlling the formation of the south-dipping subduction under the North Pamir.}
}

@Article{2022:weerdesteijn.conrad.ea:solid,
  author  = {Weerdesteijn, Maaike F. M. and Conrad, Clinton P. and Naliboff, John B.},
  title   = {Solid Earth Uplift Due To Contemporary Ice Melt Above Low-Viscosity Regions of the Upper Mantle},
  journal = {Geophysical Research Letters},
  year    = 2022,
  volume  = 49,
  pages   = 386,
  issue   = 17,
  doi     = {10.1029/2022GL099731}
}


@Article{2022:cloetingh.koptev.ea:fingerprinting,
  author  = {Cloetingh, Sierd and Koptev, Alexander and Lavecchia, Alessio and Kov\'acs, Istv\'an J\'anos and Beekman, Fred},
  title   = {Fingerprinting secondary mantle plumes},
  journal = {Earth and Planetary Science Letters},
  year    = 2022,
  volume  = 597,
  pages   = 117819,
  doi     = {10.1016/j.epsl.2022.117819},
  url     = {http://doi.org/10.1016/j.epsl.2022.117819}
}

@article{https://doi.org/10.1029/2022GL100330,
author = {Holt, Adam F.},
title = {The topographic signature of mantle pressure build-up beneath subducting plates: A numerical modeling study},
journal = {Geophysical Research Letters},
volume = {49},
number = {22},
pages = {e2022GL100330},
keywords = {Subduction dynamics, Mantle dynamics, Dynamic topography, Mantle flow},
doi = {10.1029/2022GL100330},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2022GL100330},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2022GL100330},
note = {e2022GL100330 2022GL100330},
abstract = {Abstract Subduction zones are associated with spatially heterogeneous pressure fields that, depending on location, push/pull on Earth’s surface producing dynamic topography. Despite this, subduction zones, and associated pressure fields, are typically over-simplified within global mantle flow models. Here, I use subduction models within a global domain to probe mantle pressure build-up beneath subducting plates (SPs) and the resulting dynamic topography. Positive pressure develops beneath the SP in most subduction models. This produces positive dynamic topography ( less than 450 m) and tilts the SP upwards towards the trench ( less than 0.25 m/km). As SP size increases, the magnitude of this pressure increases which, in turn, produces greater topography/tilting. At a global scale, I find potential evidence for the modeled tilting. I argue that the rigorous incorporation of subduction zones into mantle flow models, and hence the inclusion of this signal, is needed to continue to bring future dynamic topography predictions and observational estimates into closer alignment.},
year = {2022}
}

@article{https://doi.org/10.1029/2022TC007491,
author = {Maestrelli, D. and Brune, S. and Corti, G. and Keir, D. and Muluneh, A. A. and Sani, F.},
title = {Analog and Numerical Modeling of Rift-Rift-Rift Triple Junctions},
journal = {Tectonics},
volume = {41},
number = {10},
pages = {e2022TC007491},
keywords = {analog modeling, numerical modeling, triple junction, Rift-Rift-Rift junction, rifting, Afar},
doi = {https://doi.org/10.1029/2022TC007491},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2022TC007491},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2022TC007491},
note = {e2022TC007491 2022TC007491},
abstract = {Abstract Rift-Rift-Rift triple junctions are key features of emergent plate boundary networks during fragmentation of a continent. A key example of such a setting is the Afar triple junction where the African, Arabian and Somalian plates interact. We performed analog and numerical models simulating continental break-up in a Rift-Rift-Rift setting to investigate the resulting structural pattern and evolution. We modified the ratio between plate velocities, and we performed single-stage (with all plates moving at the same time) and two-stage (where one plate first moves alone and then all the plates move simultaneously) models. Additionally, the direction of extension was changed to induce orthogonal extension in one of the three rift branches. Our models suggest that differential extension velocities in the rift branches determine the localization of the structural triple junction, which is located closer to the rift branch experiencing slower extension velocities. Furthermore, imposed velocities affect the deformation resulting in end-member fault patterns. The effect of applying similar velocities in all rift arms is to induce a symmetric fault pattern (generating a Y-shaped geometry). In contrast, a faster plate generates structures trending orthogonal to dominant velocity vectors, while faults associated with the movement of the slower plates remain subordinate (generating a T-shaped pattern). Two-stage models reveal high-angle faults interacting at the triple junction, confirming that differential extension velocities strongly affect fault patterns. These latter models show large-scale similarities with fault patterns observed in the Afar triple junction, providing insights into the factors controlling the structural evolution of this area.},
year = {2022}
}

@article{CHISENGA2022104752,
title = {Localization of large intraplate earthquakes along faulted density-contrast boundaries: Insights from the 2017 Mw6.5 Botswana earthquake},
journal = {Journal of African Earth Sciences},
pages = {104752},
year = {2022},
issn = {1464-343X},
doi = {10.1016/j.jafrearsci.2022.104752},
url = {https://www.sciencedirect.com/science/article/pii/S1464343X22003041},
author = {Chikondi Chisenga and Folarin Kolawole and Tahiry Rajaonarison and Estella A. Atekwana and Jianguo Yan and Elisha M. Shemang},
keywords = {Intraplate earthquake, Lower crust, Gravity inversion, Density, Fault reactivation, Limpopo-shashe belt},
abstract = {The fault structure and other major controls on strain localization of deep crustal intraplate earthquakes remain enigmatic due to their deep hypocentral depths and rarity of coseismic surface ruptures. Here, we investigate the 3-D crustal density structure of the 2017 Mw 6.5 Botswana earthquake epicentral region, a strong lower-crustal (~24-29 km) event which is suspected to have reactivated a Precambrian thrust in tension, possibly associated with fluid pressurization. We performed a 3-D inversion of the gravity data using published geological constraints, and integrate the resulting density model with aftershock hypocenters of the earthquake event. Our results reveal steep blocks of density anomalies, with the aftershocks clustering along a prominent NW-trending, NE-dipping density contrast separating a high-density (>2708 kg/m3) footwall and lower-density (2670-2700 kg/m3) hanging wall blocks. Additionally, a secondary, SW-dipping density contrast boundary in the hanging wall coincides with a splay of aftershock hypocenter clusters at depth. Our observations suggest that the 2017 Mw6.5 Botswana earthquake is associated with the dynamic reactivation of multiple distinct strands of long-lived basement faults representing prominent deep-reaching density contrasts in the crust. As an inference from the results of gravity inversion presented in this study, we propose that such crustal-scale intraplate fault segments associated with density contrast boundaries may represent potential stress concentrators where future deep intraplate earthquakes can localize.}
}

@article{SRIVASTAVA2022105464,
title = {Early Cretaceous mafic dykes from the Chhota Nagpur Gneissic Terrane, eastern India: evidence of multiple magma pulses for the main stage of the Greater Kerguelen mantle plume},
journal = {Journal of Asian Earth Sciences},
pages = {105464},
year = {2022},
issn = {1367-9120},
doi = {10.1016/j.jseaes.2022.105464},
url = {https://www.sciencedirect.com/science/article/pii/S1367912022003959},
author = {Rajesh K. Srivastava and Fei Wang and Wenbei Shi and Richard E. Ernst},
keywords = {Early Cretaceous, dolerite dykes, Ar-Ar date, Greater Kerguelen LIP, Eastern India},
abstract = {Early Cretaceous NNW- to WNW-trending dolerite dykes of the eastern Indian Shield, collectively termed the Raniganj-Koderma swarm, are studied for their emplacement ages and petrogenetic history, and assessed for a possible linkage with the Greater Kerguelen plume. 40Ar/39Ar dates of four dolerite dykes from different locations in the Chhota Nagpur Gneissic Terrane, indicate three pulses of emplacement ca. 118-116 Ma, ca. 112-111 Ma, and ca. 109 Ma. Geochemistry of 19 samples analysed herein (and an additional 12 samples from literature) shows sub-alkaline high-Mg tholeiitic basaltic andesite compositions. All the dyke sets belonging to the Raniganj-Koderma swarm with sub-sets WNW-trending ca. 118 Ma, NNW-trending ca. 116 Ma Salma, and a N-S trending ca. 109 Ma dyke show similar chemistry. However, NW-trending dykes emplaced ca. 112-111 Ma have slightly different geochemical characteristics. Key trace element geochemistry data, particularly Nb/Y, Zr/Y, Nb/Yb, Ti/Yb, Th/Nb and Th/Yb ratios, indicates derivation from mantle melts generated from interaction of a plume with a spreading ridge (producing OIB - E-MORB melts) with a minor role for interaction with an enriched lithospheric mantle metasomatized during an earlier (pre-Mesozoic time) subduction event. Spatiotemporal distribution of the studied dolerite dykes connects them with the second plume head phase of the Greater Kerguelen mantle plume.}
}

@article{https://doi.org/10.1029/2022GL101130,
author = {Dong, Miao and L{\"u}, ChuanChuan and Zhang, Jian and Hao, Tianyao},
title = {Downgoing plate-buoyancy driven retreat of North Sulawesi Trench: Transition of a passive margin into a subduction zone},
journal = {Geophysical Research Letters},
year = {2022},
volume = {49},
number = {23},
pages = {e2022GL101130},
doi = {10.1029/2022GL101130},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2022GL101130},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2022GL101130},
note = {e2022GL101130 2022GL101130},
abstract = {Abstract The transition of a passive continental margin into a subduction zone remains a hypothesis because few geological cases have been reported. The North Sulawesi subduction zone is a 5-9 myr system in Southeast Asia that has evolved from a passive continental margin and has long been overlooked by studies of passive to active margin transitions. Here we compare geophysical evidence from the region with our numerical simulation results. We find that the initial subduction of North Sulawesi relies on horizontal stress, where the trench retreat depends on the negative buoyancy of the oceanic lithosphere. Furthermore, less space available for subduction leads to reduced mantle flow caused by subduction and slower trench retreat. These new dynamical constraints indicate that the negative buoyancy of the oceanic plate is a key factor for the trench retreat, even though subduction initiated was induced.}
}

@article{ZHANG2022229636,
title = {Late Mesozoic multi-plate convergence in East Asia: Insights from 3-D global mantle flow models},
journal = {Tectonophysics},
pages = {229636},
year = {2022},
issn = {0040-1951},
doi = {10.1016/j.tecto.2022.229636},
url = {https://www.sciencedirect.com/science/article/pii/S0040195122004309},
author = {Zhen Zhang and Qunfan Zheng and Huai Zhang and Qin Wang and Yaolin Shi},
keywords = {Global mantle flow, Dynamic topography, Mesozoic multi-plate convergence, East Asia, Numerical modeling},
abstract = {Due to the Mesozoic multi-plate convergence, prominent continental marginal tectonic belts were formed in East Asia. The significant intra-continental magmatic events in the interior of East Asia were also closely related to the subduction of the surrounding oceans. Therefore, clarifying the subduction-related mantle dynamics during the Mesozoic super-convergence in East Asia is critical in understanding the crust-mantle interactions and the episodic tectono-magmatism. In this study, we obtain the subduction-related dynamic topography by coupling global mantle flow and plate reconstruction motions to capture the evolution scenarios in 200–90 Ma. Our modeling results are as follows: (1) In the Early Jurassic, the East Asian continental margin breakup is closely related to the mantle-driven dynamic topography. The offshore dynamic subsidence dominates the continental breakup. (2) The closure of the Paleo-Tethys Ocean and the subduction of the Bangonghu-Nujiang Ocean contribute to the southward migration of the dynamic topography. Concurrently, the continuous subduction of the Paleo-Pacific Plate leads to the onshore dynamic uplift, which results in subduction-related orogenesis in eastern East Asia. The dynamic uplift does not massively progress westward in Mainland China, suggesting that extensive intra-continental compressional deformation results from tectonic uplift rather than mantle-induced dynamic uplift. (3) The regression of the dynamic subsidence zone since 130 Ma marks the start of the topographic collapse in the East Asian continental margin through the back-arc extension. (4) The alternating compression-extension scenarios are identified in the main compressional and extensional stages, respectively, showing that dynamic topography is closely related to the evolution of the marginal tectonic belts in eastern East Asia. In conclusion, the subduction-related dynamic topography systematically reveals the deep dynamics involved in the formation, evolution, and collapse of the marginal tectonic belts in East Asia and is of great significance in understanding the related mantle dynamics during the Late Mesozoic.}
}

@article{LIU2023229679,
title = {Evolution of pull-apart basins with overlapping NE-trending strike-slip fault systems in the northern South China Sea margin: Insight from numerical modeling},
journal = {Tectonophysics},
volume = {846},
pages = {229679},
year = {2023},
issn = {0040-1951},
doi = {https://doi.org/10.1016/j.tecto.2022.229679},
url = {https://www.sciencedirect.com/science/article/pii/S0040195122004735},
author = {Ze Liu and Sanzhong Li and Yanhui Suo and S. Wajid Hanif Bukhari and Xuesong Ding and Jie Zhou and Pengcheng Wang and Haohao Cheng and Ian Somerville},
keywords = {Basin evolution, Basin dynamics, Numerical modeling, Pull-apart basin, Tectonic topography},
abstract = {A pull-apart basin is a significant type of oil-bearing basin. Its formation mechanism is a hot and challenging issue in geodynamic research that involves the interaction of three-dimensional faults and stress states. In particular, the systematic and quantitative interpretation of the three-dimensional mechanism is not clear. Therefore, we use ASPECT simulation software to analyze how the main dynamic parameters affect the evolution of the basins. The following features were recognised: (1) The greater the degree of overlapping between parallel strike-slip faults, the longer the time of rapid subsidence at the initial stage, but the larger the range of subsidence and the shallower the depth of subsidence at the final stage. (2) All models generate two small basins at the beginning, but they connected together at different stages. The antithetic end-member models of different spacing faults subsided rapidly at the initial stage. However, the two independently developed small basins were connected with time. (3) Based on the comprehensive comparison of numerical modeling results with the evolution of strike-slip faulting in the Pearl River Mouth Basin (PRMB) in the northern South China Sea margin, this paper proposes that the 120° overlapping releasing stepover pattern is likely dominant at the early stage. Furthermore, this study finds a linear relationship between the strike-slip displacements and the depths of basin depocenter. Based on this relationship, the displacements of master strike-slip faults on both sides of the Baiyun Sag of the PRMB are less than 3.5 km. It can further help to understand the formation mechanism of the PRMB.}
}

@article{LIU2022105509,
title = {Deep-shallow coupling mechanism in pull-apart basins: Insight from 3D numerical simulation},
journal = {Journal of Asian Earth Sciences},
pages = {105509},
year = {2022},
issn = {1367-9120},
doi = {https://doi.org/10.1016/j.jseaes.2022.105509},
url = {https://www.sciencedirect.com/science/article/pii/S1367912022004400},
author = {Ze Liu and Sanzhong Li and Liming Dai and Yanhui Suo and Guangzeng Wang and Wang Pengcheng and S. {Wajid Hanif Bukhari}},
keywords = {Pull-apart basin, Strike-slip fault, Coupled thermo-mechanical and surface process modeling, Deep dynamics, Earth’s surface system},
abstract = {Strike-slip faults in pull‐apart basins commonly display complex 3D geometric structures, which makes it challengeable to interpret spatial and temporal evolution of the basins. Coupled thermo-mechanical and surface process models represent a powerful tool to investigate structural development of pull-apart basins and the associated sedimentary architectures. We set up three cases with representative end-member strike-slip fault patterns: 45° underlapping releasing stepover, 90° non-overlapping releasing stepover, and 135° overlapping releasing stepover. Our numerical models have successfully simulated the evolution of the developed dextral strike-slip fault systems. According to the simulation results, we found that the sediment distribution varied in each model at different stages of the basin evolution. In the beginning, the sedimentary range is the largest in the 45° underlapping releasing stepover model, but it is the smallest at the end. However, the 135° overlapping releasing stepover model showes the opposite result. Furthermore, the geometry of the basin usually depends on the underlying fault system. We observed that the activity of internal/inside faults is gradually becoming higher than that of external/outside faults as the basin evolves. Therefore, we conclude that internal normal faults are more important for basin development than external normal faults, especially in the 135° overlapping releasing stepover model. Specifically, the shape of basin basement changes from U to V at this stage because the newly developed faults are mainly concentrated in the depocenter causing rapid subsidence in the final stage of the overlapping model.}
}

@Article{Bahadori2022b,
author={Bahadori, Alireza
and Holt, William E.
and Austermann, Jacqueline
and Campbell, Lajhon
and Rasbury, E. Troy
and Davis, Daniel M.
and Calvelage, Christopher M.
and Flesch, Lucy M.},
title={The role of gravitational body forces in the development of metamorphic core complexes},
journal={Nature Communications},
year={2022},
month=sep,
day={26},
volume={13},
number={1},
pages={5646},
abstract={Within extreme continental extension areas, ductile middle crust is exhumed at the surface as metamorphic core complexes. Sophisticated quantitative models of extreme extension predicted upward transport of ductile middle-lower crust through time. Here we develop a general model for metamorphic core complexes formation and demonstrate that they result from the collapse of a mountain belt supported by a thickened crustal root. We show that gravitational body forces generated by topography and crustal root cause an upward flow pattern of the ductile lower-middle crust, facilitated by a detachment surface evolving into low-angle normal fault. This detachment surface acquires large amounts of finite strain, consistent with thick mylonite zones found in metamorphic core complexes. Isostatic rebound exposes the detachment in a domed upwarp, while the final Moho discontinuity across the extended region relaxes to a flat geometry. This work suggests that belts of metamorphic core complexes are a fossil signature of collapsed highlands.},
issn={2041-1723},
doi={10.1038/s41467-022-33361-2},
url={https://doi.org/10.1038/s41467-022-33361-2}
}

@article{https://doi.org/10.1029/2022GC010648,
author = {Hollyday, Andrew and Austermann, Jacqueline and Lloyd, Andrew and Hoggard, Mark and Richards, Fred and Rovere, Alessio},
title = {A revised estimate of early Pliocene global mean sea level using geodynamic models of the Patagonian slab window},
journal = {Geochemistry, Geophysics, Geosystems},
year={2023},
volume = {24},
number = {n/a},
pages = {e2022GC010648},
keywords = {Geodynamics, Sea-level change, Pliocene, Glacial Isostatic Adjustment, Mantle Convection, Patagonia},
doi = {10.1029/2022GC010648},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2022GC010648},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2022GC010648},
note = {e2022GC010648 2022GC010648},
abstract = {Abstract Paleoshorelines serve as measures of ancient sea level and ice volume but are affected by solid Earth deformation including processes such as glacial isostatic adjustment (GIA) and mantle dynamic topography (DT). The early Pliocene Epoch is an important target for sea-level reconstructions as it contains information about the stability of ice sheets during a climate warmer than today. Along the southeastern passive margin of Argentina, three paleoshorelines date to early Pliocene times (4.8 to 5.5 Ma), and their variable present-day elevations (36 to 180 m) reflect a unique topographic deformation signature. We use a mantle convection model to back-advect present-day buoyancy variations, including those that correspond to the Patagonian slab window. Varying the viscosity and initial tomography-derived mantle buoyancy structures allows us to compute a suite of predictions of DT change that, when compared to GIA-corrected shoreline elevations, makes it possible to identify both the most likely convection parameters and the most likely DT change. Our simulations illuminate an interplay of upwelling asthenosphere through the Patagonian slab window and coincident downwelling of the subducted Nazca slab in the mantle transition zone. This flow leads to differential upwarping of the southern Patagonian foreland since early Pliocene times, in line with the observations. Using our most likely DT change leads to an estimate of global mean sea level of 17.5 ± 6.4 m (1σ) in the early Pliocene Epoch. This confirms that sea level was significantly higher than present and can be used to calibrate ice sheet models.}
}
@article{https://doi.org/10.1029/2022GL099286,
author = {Heilman, Erin and Becker, Thorsten W.},
title = {Plume-Slab Interactions Can Shut Off Subduction},
journal = {Geophysical Research Letters},
volume = {49},
number = {13},
pages = {e2022GL099286},
keywords = {mantle convection, mantle plume, subduction zone, modeling},
doi = {10.1029/2022GL099286},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2022GL099286},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2022GL099286},
note = {e2022GL099286 2022GL099286},
abstract = {Abstract Mantle plumes are typically considered secondary features of mantle convection, yet their surface effects over Earth's evolution may have been significant. We use 2-D convection models to show that mantle plumes can in fact cause the termination of a subduction zone. This extreme case of plume-slab interaction is found when the slab is readily weakened, for example, by damage-type rheology, and the subducting slab is young. We posit that this mechanism may be relevant, particularly for the early Earth, and a subdued version of these plume-slab interactions may remain relevant for modern subduction zones. Such core-mantle boundary–surface interactions may be behind some of the complexity of tomographically imaged mantle structures, for example, in South America. More generally, plume “talk back” to subduction zones may make plate tectonics more episodic.},
year = {2022}
}

@article{https://doi.org/10.1029/2022JB025229,
author = {Pons, Michaël and Sobolev, Stephan V. and Liu, Sibiao and Neuharth, Derek},
title = {Hindered Trench Migration Due To Slab Steepening Controls the Formation of the Central Andes},
journal = {Journal of Geophysical Research: Solid Earth},
volume = {127},
number = {12},
pages = {e2022JB025229},
keywords = {Central Andes, subduction dynamics, geodynamics, shortening, steepening, flat-slab},
doi = {10.1029/2022JB025229},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2022JB025229},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2022JB025229},
note = {e2022JB025229 2022JB025229},
abstract = {Abstract The formation of the Central Andes dates back to ∼50 Ma, but its most pronounced episode, including the growth of the Altiplano-Puna Plateau and pulsatile tectonic shortening phases, occurred within the last 25 Ma. The reason for this evolution remains unexplained. Using geodynamic numerical modeling we infer that the primary cause of the pulses of tectonic shortening and growth of the Central Andes is the changing geometry of the subducted Nazca plate, and particularly the steepening of the mid-mantle slab segment which results in a slowing down of the trench retreat and subsequent increase in shortening of the advancing South America plate. This steepening first happens after the end of the flat slab episode at ∼25 Ma, and later during the buckling and stagnation of the slab in the mantle transition zone. Processes that mechanically weaken the lithosphere of the South America plate, as suggested in previous studies, enhance the intensity of the shortening events. These processes include delamination of the mantle lithosphere and weakening of foreland sediments. Our new modeling results are consistent with the timing and amplitude of the deformation from geological data in the Central Andes at the Altiplano latitude.},
year = {2022}
}

@article{https://doi.org/10.1029/2020GL090483,
author = {Rajaonarison, Tahiry A. and Stamps, D. Sarah and Naliboff, John},
title = {Role of Lithospheric Buoyancy Forces in Driving Deformation in East Africa From 3D Geodynamic Modeling},
journal = {Geophysical Research Letters},
volume = {48},
number = {6},
pages = {e2020GL090483},
keywords = {East African Rift, geodynamics, gravitational potential energy, lithospheric buoyancy forces, lithospheric deformation, surface motion},
doi = {https://doi.org/10.1029/2020GL090483},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2020GL090483},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2020GL090483},
note = {e2020GL090483 2020GL090483},
abstract = {Abstract Despite decades of investigation, the origin of forces driving continental rifting remains highly debated. Deciphering their relative contributions is challenging due to the nonlinear and depth-dependent nature of lithospheric rheology. Recent geodynamic studies of the East African Rift (EAR) report contradicting results regarding the relative contribution of horizontal mantle tractions and lithospheric buoyancy forces. Here, we use high-resolution 3D regional numerical modeling of the EAR to isolate the contribution lithospheric buoyancy forces to observed deformation. Modeled surface velocities closely match kinematic models of the Somalian Plate, Victoria Block, and Rovuma Block motions, but provide poor fit to along-rift surface motions in deforming zones. These results suggest that lithospheric buoyancy forces primarily drive present-day ∼E-W extension across the EAR, but intrarift deformation may result from viscous coupling to horizontal asthenospheric flow.},
year = {2021}
}

@article{10.1130/G50734.1,
    author = {Heron, Philip J. and Peace, A.L. and McCaffrey, K.J.W. and Sharif, A. and Yu, A.J. and Pysklywec, R.N.},
    title = {Stranding continental crustal fragments during continent breakup: Mantle suture reactivation in the Nain Province of Eastern Canada},
    journal = {Geology},
    year = {2023},
    month = {02},
    issn = {0091-7613},
    doi = {10.1130/G50734.1},
    url = {https://doi.org/10.1130/G50734.1},
    eprint = {https://pubs.geoscienceworld.org/gsa/geology/article-pdf/doi/10.1130/G50734.1/5780065/g50734.pdf},
}

@article{10.1130/G49351.1,
    author = {Neuharth, Derek and Brune, Sascha and Glerum, Anne and Morley, Chris K. and Yuan, Xiaoping and Braun, Jean },
    title = {Flexural strike-slip basins},
    journal = {Geology},
    volume = {50},
    number = {3},
    pages = {361-365},
    year = {2022},
    month = {12},
    issn = {0091-7613},
    doi = {10.1130/G49351.1},
    url = {https://doi.org/10.1130/G49351.1},
    eprint = {https://pubs.geoscienceworld.org/gsa/geology/article-pdf/50/3/361/5552818/g49351.1.pdf},
}

@article{https://doi.org/10.1029/2020GC009615,
author = {Neuharth, Derek and Brune, Sascha and Glerum, Anne and Heine, Christian and Welford, J. Kim},
title = {Formation of Continental Microplates Through Rift Linkage: Numerical Modeling and Its Application to the Flemish Cap and Sao Paulo Plateau},
journal = {Geochemistry, Geophysics, Geosystems},
volume = {22},
number = {4},
pages = {e2020GC009615},
doi = {10.1029/2020GC009615},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2020GC009615},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2020GC009615},
note = {e2020GC009615 2020GC009615},
year = {2021}
}

@article{https://doi.org/10.1029/2020TC006553,
author = {Richter, Maximilian J. E. A. and Brune, Sascha and Riedl, Simon and Glerum, Anne and Neuharth, Derek and Strecker, Manfred R.},
title = {Controls on Asymmetric Rift Dynamics: Numerical Modeling of Strain Localization and Fault Evolution in the Kenya Rift},
journal = {Tectonics},
volume = {40},
number = {5},
pages = {e2020TC006553},
keywords = {asymmetric rifting, rift variability, numerical model, structural inheritance, Kenya Rift},
doi = {10.1029/2020TC006553},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2020TC006553},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2020TC006553},
note = {e2020TC006553 2020TC006553},
year = {2021}
}

@article{https://doi.org/10.1029/2021TC007166,
author = {Neuharth, Derek and Brune, Sascha and Wrona, Thilo and Glerum, Anne and Braun, Jean and Yuan, Xiaoping},
title = {Evolution of Rift Systems and Their Fault Networks in Response to Surface Processes},
journal = {Tectonics},
volume = {41},
number = {3},
pages = {e2021TC007166},
keywords = {rifts, fault network, surface processes, geodynamics},
doi = {10.1029/2021TC007166},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2021TC007166},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2021TC007166},
note = {e2021TC007166 2021TC007166},
year = {2022}
}

@Article{WeerdesteijnIceLoading2022,
  author  = {Weerdesteijn, Maaike F. M. and Naliboff, John B. and Conrad, Clinton P. and Reusen, Jesse M. and Steffen, Rebekka and Heister, Timo and Zhang, Jiaqi},
  title   = {Modeling Viscoelastic Solid Earth Deformation Due To Ice Age and Contemporary Glacial Mass Changes in {ASPECT}},
  journal = {Geochemistry, Geophysics, Geosystems},
  year    = {2023},
  volume  = {24},
  number  = {3},
  pages   = {e2022GC010813},
  doi     = {10.1029/2022GC010813},
}

@article{2021-0192guochangsheng,
title = "Geodynamical simulation of the effects of ridge subduction on the scale of the seismogenic zone south of Chile Triple Junction",
journal = "Acta Seismologica Sinica",
volume = "45",
number = "2021-0192guochangsheng",
pages = "1",
year = "2023",
note = "",
issn = "0253-3782",
doi = "10.11939/jass.20210192",
url = "https://www.dzxb.org/en/article/doi/10.11939/jass.20210192",
author = "Guo, Changsheng and Sun, Pengchao and Wei, Dongping",
keywords = "Chile Triple Junction, ridge subduction, seismogenic zone, numerical simulation"
}

@article{ZHENGQunFanChineseJournalofGeophysics,
title = {Upper mantle anisotropy and dynamics beneath Cenozoic South China and its surroundings: insights from numerical simulation},
journal = {Chinese Journal of Geophysics (in Chinese)},
volume = {},
number = {},
pages = {},
year = {2023},
issn = {0001-5733},
doi = {10.6038/cjg2022P0780},
url = {http://www.geophy.cn//article/id/6f4f31c9-c5a2-4696-b2e6-72e33a26b7f3},
author = {Zheng, QunFan and  Zhang, Huai and  Wang, Qin and  Zhang, Zhen and  Shi, YaoLin},
keywords = {Mantle convection, Anisotropy, Asthenosphere, South China, Numerical modeling}
}

@Article{se-14-389-2023,
AUTHOR = {Schmid, T. C. and Brune, S. and Glerum, A. and Schreurs, G.},
TITLE = {Tectonic interactions during rift linkage: insights from analog and
numerical experiments},
JOURNAL = {Solid Earth},
VOLUME = {14},
YEAR = {2023},
NUMBER = {4},
PAGES = {389--407},
URL = {https://se.copernicus.org/articles/14/389/2023/},
DOI = {10.5194/se-14-389-2023}
}

@mastersthesis { 2023limitsofte,
	title = {Limits of tectonic reactivation on Mars using Earth analogue analysis and numerical modeling},
	institution = {Mississippi State University},
	month = may,
	publisher = {Theses and Dissertations},
	url = {https://scholarsjunction.msstate.edu/cgi/viewcontent.cgi?article=6815&context=td},
	volume = {5783},
	year = {2023},
	isbn = {},
	doi = {},
	author = {Rich, Jonathan}
}

@article{https://doi.org/10.1029/2022GC010843,
author = {Lanari, R. and Faccenna, C. and Natali, C. and Şengül Uluocak, E. and Fellin, M. G. and Becker, T. W. and Göğüş, O. H. and Youbi, N. and Clementucci, R. and Conticelli, S.},
title = {The Atlas of Morocco: A Plume-Assisted Orogeny},
journal = {Geochemistry, Geophysics, Geosystems},
volume = {24},
number = {6},
pages = {e2022GC010843},
keywords = {Atlas, plume-assisted orogeny, deformation, anorogenic volcanism},
doi = {10.1029/2022GC010843},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2022GC010843},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2022GC010843},
note = {e2022GC010843 2022GC010843},
abstract = {Abstract We explore the connections between crustal shortening, volcanism, and mantle dynamics in the Atlas of Morocco. In response to compressional forces and strain localization, this intraplate orogen has evolved far from convergent plate margins. Convective effects, such as lithospheric weakening and plume-related volcanism, contributed in important ways to the building of high topography. We seek to better understand how crustal and mantle processes interacted during the Atlas' orogeny by combining multiple strands of observations, including new and published data. Constraints on crustal and thermal evolution are combined with new analyses of topographic evolution, petrological, and geochemical data from the Anti-Atlas volcanic fields, and a simple numerical model of the interactions among crustal deformation, a mantle plume, and volcanism. Our findings substantiate that: (a) crustal deformation and exhumation accelerated during the middle/late Miocene, contemporaneous with the onset of volcanism; (b) volcanism has an anorogenic signature with a deep source; (c) a dynamic mantle upwelling supports the high topography. We propose that a mantle plume and the related volcanism weakened the lithosphere beneath the Atlas and that this favored the localization of crustal shortening along pre-existing structures during plate convergence. This convective-tectonic sequence may represent a general mechanism for the modification of continental plates throughout the thermo-chemical evolution of the supercontinental cycle.},
year = {2023}
}

@article{https://doi.org/10.1029/2022JB025800,
author = {Rajaonarison, Tahiry A. and Stamps, D. Sarah and Naliboff, John and Nyblade, Andrew and Njinju, Emmanuel A.},
title = {A Geodynamic Investigation of Plume-Lithosphere Interactions Beneath the East African Rift},
journal = {Journal of Geophysical Research: Solid Earth},
volume = {128},
number = {4},
pages = {e2022JB025800},
keywords = {mantle tractions, African Superplume, East African Rift, plume-lithosphere interactions, seismic anisotropy},
doi = {10.1029/2022JB025800},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2022JB025800},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2022JB025800},
note = {e2022JB025800 2022JB025800},
abstract = {Abstract The force balance that drives and maintains continental rifting to breakup is poorly understood. The East African Rift (EAR) provides an ideal natural laboratory to elucidate the relative role of plate driving forces as only lithospheric buoyancy forces and horizontal mantle tractions act on the system. Here, we employ high-resolution 3D thermomechanical models to test whether: (a) the anomalous, rift-parallel surface deformation observed by Global Navigation Satellite System (GNSS) data in the EAR are driven by viscous coupling to northward mantle flow associated with the African Superplume, and (b) the African Superplume is the dominant source mechanism of anomalous rift-parallel seismic anisotropy beneath the EAR. We calculate Lattice Preferred Orientations (LPO) and surface deformation from two types of mantle flow: (a) a scenario with multiple plumes constrained by shear wave tomography and (b) a single superplume model with northward boundary condition to simulate large-scale flow. Comparison of calculated LPO with observed seismic anisotropy, and surface velocities with GNSS and plate kinematics reveal that there is a better fit with the superplume mantle flow model, rather than the tomography-based (multiple plumes) model. We also find a relatively better fit spatially between observed seismic anisotropy and calculated LPO with the superplume model beneath northern and central EAR, where the superplume is proposed to be shallowest. Our results suggest that the viscous coupling of the lithosphere to northward mantle flow associated with the African Superplume drives most of the rift-parallel deformation and is the dominant source of the first-order pattern of the observed seismic anisotropy in the EAR.},
year = {2023}
}

@article{10.1093/gji/ggac455,
    author = {Neuharth, Derek and Mittelstaedt, Eric},
    title = "{Temporal variations in plume flux: characterizing pulsations from tilted plume conduits in a rheologically complex mantle}",
    journal = {Geophysical Journal International},
    volume = {233},
    number = {1},
    pages = {338-358},
    year = {2022},
    month = {11},
    issn = {0956-540X},
    doi = {10.1093/gji/ggac455},
    url = {https://doi.org/10.1093/gji/ggac455},
    eprint = {https://academic.oup.com/gji/article-pdf/233/1/338/48351630/ggac455.pdf},
}

@article{He2023,
  doi = {10.1038/s41467-023-40147-7},
  url = {https://doi.org/10.1038/s41467-023-40147-7},
  year = {2023},
  month = jul,
  publisher = {Springer Science and Business Media {LLC}},
  volume = {14},
  number = {1},
  author = {He, John J. Y. and  Kapp, Paul},
  title = {Basin record of a Miocene lithosphere drip beneath the Colorado Plateau},
  journal = {Nature Communications}
}

@mastersthesis { 2023Amerongen,
	title = {3D instantaneous dynamics modelling of the surface motion associated with East European subduction zones},
	school = {Utrecht University},
	url = {https://studenttheses.uu.nl/handle/20.500.12932/44238},
	year = {2023},
	author = {van Amerongen, A.J.}
}

@article{BODUR2023118309,
title = {Crustal flow driving twin domes exhumation and low-angle normal faulting in the Menderes Massif of western Anatolia},
journal = {Earth and Planetary Science Letters},
volume = {619},
pages = {118309},
year = {2023},
issn = {0012-821X},
doi = {10.1016/j.epsl.2023.118309},
url = {https://www.sciencedirect.com/science/article/pii/S0012821X23003229},
author = {Ömer Bodur and Oğuz Hakan Göğüş and Sascha Brune and Ebru {Şengül Uluocak} and Anne Glerum and Andreas Fichtner and Hasan Sözbilir},
keywords = {geodynamic modeling, lower crustal flow, western Anatolia}
}

@article{10.1093/gji/ggad319,
    author = {Lee, Sungho and Song, Jung-Hun and Heo, Dabeen and Rhie, Junkee and Kang, Tae-Seob and Choi, Eunseo and Kim, YoungHee and Kim, Kwang-Hee and Ree, Jin-Han},
    title = "{Crustal and uppermost mantle structures imaged by teleseismic P-wave travel-time tomography beneath the Southeastern Korean peninsula: implications for a hydrothermal system controlled by the thermally modified lithosphere}",
    journal = {Geophysical Journal International},
    pages = {ggad319},
    year = {2023},
    month = {08},
    issn = {0956-540X},
    doi = {10.1093/gji/ggad319},
    url = {https://doi.org/10.1093/gji/ggad319},
    eprint = {https://academic.oup.com/gji/advance-article-pdf/doi/10.1093/gji/ggad319/51091828/ggad319.pdf}
}

@article{doi:10.1144/SP542-2023-12,
author = {Philip J. Heron  and Erkan Gün  and Grace E. Shephard  and Juliane Dannberg  and Rene Gassmöller  and Erin Martin  and Aisha Sharif  and Russell N. Pysklywec  and R. Damian Nance  and J. Brendan Murphy },
title = {The role of subduction in the formation of Pangean oceanic large igneous provinces},
journal = {Geological Society, London, Special Publications},
volume = {542},
number = {1},
pages = {SP542-2023-12},
year = {2024},
doi = {10.1144/SP542-2023-12},
URL = {https://www.lyellcollection.org/doi/abs/10.1144/SP542-2023-12},
eprint = {https://www.lyellcollection.org/doi/pdf/10.1144/SP542-2023-12}
}

@article{https://doi.org/10.1029/2023JB026523,
author = {Maierová, P. and Hasalová, P. and Schulmann, K. and Štípská, P. and Souček, O.},
title = {Porous melt flow in continental crust – a numerical modeling study},
journal = {Journal of Geophysical Research: Solid Earth},
volume = {128},
number = {8},
pages = {e2023JB026523},
keywords = {melt flow, numerical, model, continental crust, porous},
doi = {10.1029/2023JB026523},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2023JB026523},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2023JB026523},
note = {e2023JB026523 2023JB026523},
year = {2023}
}

@article{https://doi.org/10.1029/2022JB025036,
author = {Monaco, Martina and Dannberg, Juliane and Gassmoeller, Rene and Pugh, Stephen},
title = {Linking Geodynamic Models of Basalt Segregation in Mantle Plumes to the X-Discontinuity Observed Beneath Hotspots},
journal = {Journal of Geophysical Research: Solid Earth},
volume = {128},
number = {6},
pages = {e2022JB025036},
keywords = {mantle plumes, chemical heterogeneities, recycled crustal material, geodynamic modeling, seismic discontinuities, eclogite},
doi = {10.1029/2022JB025036},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2022JB025036},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2022JB025036},
note = {e2022JB025036 2022JB025036},
year = {2023}
}

 @article { tjb1318091,
	journal = {Türkiye Jeoloji Bülteni/Geological Bulletin of Turkey},
	year = {2023},
	pages = {1 - 17},
	doi = {10.25288/tjb.1318091},
	title = {A Discussion on Geodynamic Modeling Methodology: Inferences from Numerical Models in the Anatolian Plate},
	key = {cite},
	author = {Şengül Uluocak,  Ebru}
}

@article{https://doi.org/10.1029/2023GC011056,
author = {Liu, Xiaowen and Pysklywec, Russell},
title = {Transient Injection of Flow: How Torn and Bent Slabs Induce Unusual Mantle Circulation Patterns Near a Flat Slab},
journal = {Geochemistry, Geophysics, Geosystems},
volume = {24},
number = {10},
pages = {e2023GC011056},
keywords = {subduction, slab tear, mantle flow, numerical model, flat slab},
doi = {10.1029/2023GC011056},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2023GC011056},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2023GC011056},
note = {e2023GC011056 2023GC011056},
year = {2023}
}

@article{https://doi.org/10.1029/2023TC007765,
author = {Pons, Michaël and Rodriguez Piceda, Constanza and Sobolev, Stephan V. and Scheck-Wenderoth, Magdalena and Strecker, Manfred R.},
title = {Localization of Deformation in a Non-Collisional Subduction Orogen: The Roles of Dip Geometry and Plate Strength on the Evolution of the Broken Andean Foreland, Sierras Pampeanas, Argentina},
journal = {Tectonics},
volume = {42},
number = {8},
pages = {e2023TC007765},
keywords = {subduction, strain localization, Sierras Pampeanas, flat-slab, Andes, Nazca plate},
doi = {10.1029/2023TC007765},
url = {https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2023TC007765},
eprint = {https://agupubs.onlinelibrary.wiley.com/doi/pdf/10.1029/2023TC007765},
note = {e2023TC007765 2023TC007765},
year = {2023}
}

@article{LIU2023118420,
title = {Sensitivity of gravity anomalies to mantle rheology at mid-ocean ridge – transform fault systems},
journal = {Earth and Planetary Science Letters},
volume = {622},
pages = {118420},
year = {2023},
issn = {0012-821X},
doi = {10.1016/j.epsl.2023.118420},
url = {https://www.sciencedirect.com/science/article/pii/S0012821X23004338},
author = {Sibiao Liu and Zhikui Guo and Lars H. Rüpke and Jason P. Morgan and Ingo Grevemeyer and Yu Ren and Chuanzhi Li},
keywords = {Gravity anomaly, Mantle rheology, Mid-ocean ridge, Oceanic transform fault}
}

Missing publications Araújo et. al

@Article{araujo+wadbro+2021,
author = {Araújo, Juan C. and Wadbro, Eddie},
title = {Shape optimization for the strong directional scattering of dielectric nanorods},
journal = {International Journal for Numerical Methods in Engineering},
volume = {n/a},
number = {n/a},
pages = {},
keywords = {directional scattering, Helmholtz problem, light routing, scattering problem, shape optimization},
doi = {https://doi.org/10.1002/nme.6677},
url = {https://onlinelibrary.wiley.com/doi/abs/10.1002/nme.6677},
eprint = {https://onlinelibrary.wiley.com/doi/pdf/10.1002/nme.6677},
}

@Article{araujo+engstrom+2021,
label = {A2},
title = "On spurious solutions encountered in Helmholtz scattering resonance computations in {$R^d$} with applications to nano-photonics and acoustics",
journal = {Journal of Computational Physics},
volume = {429},
pages = {110024},
year = {2021},
issn = {0021-9991},
doi = {https://doi.org/10.1016/j.jcp.2020.110024},
url = {https://www.sciencedirect.com/science/article/pii/S0021999120307981},
author = {Juan C. {Araújo C.} and Christian Engstr"om},
keywords = {Plasmon resonance, Acoustic scattering resonances, Nonlinear eigenvalue problems, Helmholtz problem, Leaky modes, Quasi-normal modes},
}

@Article{araujo+engstrom+campos+roman+2019,
label = {A3},
author = {Juan C. {Araújo C.} and Carmen Campos and Christian Engstr"om and Jose E. Roman},
title = "Computation of scattering resonances in absorptive and dispersive media with applications to metal-dielectric nano-structures",
journal = "Journal of Computational Physics",
volume = "407",
pages = "109220",
year = "2020",
issn = "0021-9991",
doi = "https://doi.org/10.1016/j.jcp.2019.109220",
url = "http://www.sciencedirect.com/science/article/pii/S0021999119309258",
keywords = "Plasmon resonance, Resonance modes, Nonlinear eigenvalue problems, Helmholtz problem, PML, Dispersion analysis, Leaky modes, Resonant states, Quasimodes, Quasi-normal modes",
}

Make sure that full names of the authors are provided

I think some journals want to have full names of the authors of a publication (not abbreviations). So it could make sense to enforce this in dealii/publication-list for ease of usability (during code review, but this could also be added to the readme-file).

deal.II publications Thomas Wick

@book{Wi20_book,
author = "Thomas Wick",
title = "Multiphysics Phase-Field Fracture: Modeling, Adaptive Discretizations, and Solvers",
year = "2020",
publisher = "De Gruyter",
address = "Berlin, Boston",
isbn = "978-3-11-049739-7",
doi = "https://doi.org/10.1515/9783110497397",
url = "https://www.degruyter.com/view/title/523232"
}

@Unpublished{FaYiWi21_EWCO,
author = {M. Fan and Y. Jin and T. Wick},
title = {A quasi-monolithic phase-field description for mixed-mode fracture using predictor-corrector mesh adaptivity},
note = {Engineering with Computers (EWCO), accepted for publication},
year = {2021}
}

@Unpublished{Wi21_CMAM,
author = {T. Wick},
title = {Dual-weighted residual a posteriori error estimates for a penalized phase-field slit discontinuity problem},
note = {Computational Methods in Applied Mathematics (CMAM), accepted for publication},
year = {2021}
}

@Article{FrRiWi21_LocModFE,
title = {LocModFE: Locally modified finite elements for approximating interface problems in deal.II},
journal = {Software Impacts},
volume = {8},
pages = {100070},
year = {2021},
issn = {2665-9638},
doi = {https://doi.org/10.1016/j.simpa.2021.100070},
url = {https://www.sciencedirect.com/science/article/pii/S266596382100018X},
author = {Stefan Frei and Thomas Richter and Thomas Wick},
keywords = {Locally modified finite elements, Fitted finite elements, Interface problems, , Deal.II},
abstract = {We describe the Software package LocModFE, which is an implementation of a locally modified finite element method for an accurate solution of interface problems. The code was originally developed in the finite element library Gascoigne 3d and has now been rewritten in the widerspread library deal.II. This makes the concept of locally modified finite elements accessible to many users all over the world. Applications range from simple Poisson interface problems over multi-phase flows to complex multi-physics problems, such as fluid–structure interactions. Being based on deal.II, it provides plenty of possibilities for future extensions, e.g., parallel computing, multigrid solvers or mesh adaptivity.}
}

@Article{EndtLaWi20_smart,
author = {Bernhard Endtmayer and Ulrich Langer and Thomas Wick},
doi = {doi:10.1515/cmam-2020-0036},
url = {https://doi.org/10.1515/cmam-2020-0036},
title = {Reliability and Efficiency of DWR-Type A Posteriori Error Estimates with Smart Sensitivity Weight Recovering},
journal = {Computational Methods in Applied Mathematics},
volume = {21},
number = {2},
year = {2021}
}

@Article{HeiWi20,
title = "pfm-cracks: A parallel-adaptive framework for phase-field fracture propagation",
journal = "Software Impacts",
volume = "6",
pages = "100045",
year = "2020",
issn = "2665-9638",
doi = "https://doi.org/10.1016/j.simpa.2020.100045",
url = "http://www.sciencedirect.com/science/article/pii/S2665963820300361",
author = "Timo Heister and Thomas Wick",
keywords = "Phase-field fracture, Parallel computing, Primal–dual active set, Semi-smooth Newton, Adaptivity, Open-source software",
abstract = "This paper describes the main features of our parallel-adaptive open-source framework for solving phase-field fracture problems called pfm-cracks. Our program allows for dimension-independent programming in two- and three-dimensional settings. A quasi-monolithic formulation for the coupled two-component system of displacements and a phase-field indicator variable is used. The nonlinear problem is solved with a robust, efficient semi-smooth Newton algorithm. A highlight is adaptive predictor–corrector mesh refinement. The code is fully parallelized and scales to 1000 and more MPI ranks. Illustrative tests demonstrate the current capabilities, from which some are parts of benchmark collections."
}

@Article{JaWheWi21,
title = {A phase-field multirate scheme with stabilized iterative coupling for pressure driven fracture propagation in porous media},
journal = {Computers & Mathematics with Applications},
volume = {91},
pages = {176-191},
year = {2021},
note = {Robust and Reliable Finite Element Methods in Poromechanics},
issn = {0898-1221},
doi = {https://doi.org/10.1016/j.camwa.2020.11.009},
url = {https://www.sciencedirect.com/science/article/pii/S089812212030434X},
author = {Mohamad Jammoul and Mary F. Wheeler and Thomas Wick},
keywords = {Phase-field fracture, Porous media, Multirate, Iterative coupling, Benchmarks},
abstract = {Phase-field methods have the potential to simulate large scale evolution of networks of fractures in porous media without the need to explicitly track interfaces. Practical field simulations require however that robust and efficient decoupling techniques can be applied for solving these complex systems. In this work, we focus on the mechanics-step that involves the coupling of elasticity and the phase-field variable. We develop a multirate scheme in which a coarser time grid is employed for the mechanics equation (i.e., the displacements) and a finer time grid is taken for the phase-field problem. The performance of this algorithm is demonstrated for two test cases.}
}

// Please update with existing arXiv entry already available on publication list
@Article{JoLaWi20,
title = "Matrix-free multigrid solvers for phase-field fracture problems",
journal = "Computer Methods in Applied Mechanics and Engineering",
volume = "372",
pages = "113431",
year = "2020",
issn = "0045-7825",
doi = "https://doi.org/10.1016/j.cma.2020.113431",
url = "http://www.sciencedirect.com/science/article/pii/S0045782520306162",
author = "D. Jodlbauer and U. Langer and T. Wick",
keywords = "Phase-field fracture propagation, Matrix-free, Geometric multigrid, Primal–dual active set",
abstract = "In this work, we present a framework for the matrix-free solution to a monolithic quasi-static phase-field fracture model with geometric multigrid methods. Using a standard matrix-based approach within the Finite Element Method requires lots of memory, which eventually becomes a serious bottleneck. A matrix-free approach overcomes this problem and greatly reduces the amount of required memory, allowing to solve larger problems on available hardware. One key challenge is concerned with the crack irreversibility for which a primal–dual active set method is employed. Here, the active set values of fine meshes must be available on coarser levels of the multigrid algorithm. The developed multigrid method provides a preconditioner for a generalized minimal residual (GMRES) solver. This method is used for solving the linear equations inside Newton’s method for treating the overall nonlinear-monolithic discrete displacement/phase-field formulation. Several numerical examples demonstrate the performance and robustness of our solution technology. Mesh refinement studies, variations in the phase-field regularization parameter, iterations numbers of the linear and nonlinear solvers, and some parallel performances are conducted to substantiate the efficiency of the proposed solver for single fractures, multiple pressurized fractures, and a L-shaped panel test in three dimensions."
}

@Article{JoLaWi20_parallel,
author = {Jodlbauer, D. and Langer, U. and Wick, T.},
title = {Parallel Matrix-Free Higher-Order Finite Element Solvers for Phase-Field Fracture Problems},
journal = {Mathematical and Computational Applications},
volume = {25},
number = {3},
pages = {40},
year = {2020}
}

@Article{WheWiLee20,
title = {{IPACS: Integrated Phase-Field Advanced Crack Propagation Simulator. An adaptive, parallel, physics-based-discretization phase-field framework for fracture propagation in porous media}},
journal = "Computer Methods in Applied Mechanics and Engineering",
volume = "367",
pages = "113124",
year = "2020",
issn = "0045-7825",
doi = "https://doi.org/10.1016/j.cma.2020.113124",
url = "http://www.sciencedirect.com/science/article/pii/S0045782520303091",
author = "Mary F. Wheeler and Thomas Wick and Sanghyun Lee",
keywords = "Phase-field fracture, Porous media, Computer implementation, Numerical simulations, Handbook, IPACS",
abstract = "In this work, we review and describe our computational framework for solving multiphysics phase-field fracture problems in porous media. Therein, the following five coupled nonlinear physical models are addressed: displacements (geo-mechanics), a phase-field variable to indicate the fracture position, a pressure equation (to describe flow), a proppant concentration equation, and/or a saturation equation for two-phase fracture flow, and finally a finite element crack width problem. The overall coupled problem is solved with a staggered solution approach, known in subsurface modeling as the fixed-stress iteration. A main focus is on physics-based discretizations. Galerkin finite elements are employed for the displacement-phase-field system and the crack width problem. Enriched Galerkin formulations are used for the pressure equation. Further enrichments using entropy-vanishing viscosity are employed for the proppant and/or saturation equations. A robust and efficient quasi-monolithic semi-smooth Newton solver, local mesh adaptivity, and parallel implementations allow for competitive timings in terms of the computational cost. Our framework can treat two- and three-dimensional realistic field and laboratory examples. The resulting program is an in-house code named IPACS (Integrated Phase-field Advanced Crack Propagation Simulator) and is based on the finite element library deal.II. Representative numerical examples are included in this document."
}

// Please update with existing arXiv entry already available on publication list
@Article{WiWo20,
author = {Wick, Thomas and Wollner, Winnifried},
title = {Optimization with nonstationary, nonlinear monolithic fluid-structure interaction},
journal = {International Journal for Numerical Methods in Engineering},
year = {2020},
volume = {n/a},
number = {n/a},
pages = {},
keywords = {gradient-based optimization, monolithic formulation, optimal control, optimal design, unsteady nonlinear fluid-structure interaction},
doi = {10.1002/nme.6372},
url = {https://onlinelibrary.wiley.com/doi/abs/10.1002/nme.6372},
eprint = {https://onlinelibrary.wiley.com/doi/pdf/10.1002/nme.6372},
abstract = {Summary Within this work, we consider optimization settings for nonlinear, nonstationary fluid-structure interaction (FSI). The problem is formulated in a monolithic fashion using the arbitrary Lagrangian-Eulerian framework to set-up the fluid-structure forward problem. In the optimization approach, either optimal control or optimal design problems are treated. In the latter, the stiffness of the solid is estimated from given reference values. In the numerical solution, the optimization problem is solved with a gradient-based solution algorithm. The nonlinear subproblems of the FSI forward problem are solved with a Newton method including line search. Specifically, we will formally provide the backward-in-time running adjoint state used for gradient computations. Our algorithmic developments are demonstrated with some numerical examples as, for instance, extensions of the well-known fluid-structure benchmark settings and a flapping membrane test in a channel flow with elastic walls.}
}

@misc{BaMaWaWiWo20,
author = {Seshadri Basava and Katrin Mang and Mirjam Walloth and Thomas
Wick and Winnifried Wollner},
title = {Adaptive and Pressure-Robust Discretization of Incompressible Pressure-Driven Phase-Field Fracture},
howpublished = {DFG-SPP 1748 final report, book article, accepted},
year = {2020}
}

@misc{MaWi21,
author = {K. Mang and T. Wick},
title = {Numerical Studies of Different Mixed Phase-Field Fracture Models for Simulating Crack Propagation in Punctured EPDM Strips},
howpublished = {WCCM-ECCOMAS2020},
year = {2021},
url = {https://www.scipedia.com/public/Mang_Wick_2021a}
}

@misc{mang2021mixed,
title={A mixed phase-field fracture model for crack propagation in punctured EPDM strips},
author={Katrin Mang and Andreas Fehse and Nils Hendrik Kröger and Thomas Wick},
year={2021},
eprint={2104.14826},
archivePrefix={arXiv},
primaryClass={math.NA}
}

@misc{Wi21_WCCM,
author = {T. Wick},
title = {On the Adjoint Equation in Fluid-Structure Interaction},
howpublished = {WCCM-ECCOMAS2020},
year = {2021},
url = {https://www.scipedia.com/public/Wick_2021}
}

@Article{FeKroeMaWi21_PAMM,
author = {Fehse, Andreas and Kröger, Nils Hendrik and Mang, Katrin and Wick, Thomas},
title = {Crack path comparisons of a mixed phase-field fracture model and experiments in punctured EPDM strips},
journal = {PAMM},
volume = {20},
number = {1},
pages = {e202000335},
doi = {https://doi.org/10.1002/pamm.202000335},
url = {https://onlinelibrary.wiley.com/doi/abs/10.1002/pamm.202000335},
eprint = {https://onlinelibrary.wiley.com/doi/pdf/10.1002/pamm.202000335},
abstract = {Abstract Working on quasi-static phase-field fracture modeling in nearly incompressible solids for crack propagation is a challenging task. To avoid arising locking effects therein, a mixed form for the solid displacement equation is developed, resulting in two unknowns: a displacement field and a hydro-static pressure variable. In order to fulfil an inf-sup condition, stable Taylor-Hood elements are employed for the displacement-pressure system. The irreversibility condition of the crack evolution is handled by help of a primal-dual active set method. To get both a sharper crack and reasonable computational costs, adaptive meshes are used based on a predictor-corrector scheme. The crack paths from the numerical simulations are compared on the experimentally observed crack paths in carbon black filled ethylene propylene diene monomer (EPDM) rubber strips. The punctured EPDM strips with a hole and a given notch at different heights are stretched till total failure.},
year = {2021}
}

@Article{EndtLaNeiWiWo19_PAMM,
author = {Endtmayer, Bernhard and Langer, Ulrich and Neitzel, Ira and Wick, Thomas and Wollner, Winnifried},
title = {Mesh adaptivity and error estimates applied to a regularized p-Laplacian constrainted optimal control problem for multiple quantities of interest},
journal = {PAMM},
volume = {19},
number = {1},
pages = {e201900231},
doi = {https://doi.org/10.1002/pamm.201900231},
url = {https://onlinelibrary.wiley.com/doi/abs/10.1002/pamm.201900231},
eprint = {https://onlinelibrary.wiley.com/doi/pdf/10.1002/pamm.201900231},
abstract = {Abstract In this work, we derive goal-oriented error estimates and mesh adaptivity for multiple quantities of interest for optimal control problems with the regularized p-Laplace equation as constraint. We apply the dual-weighted residual method to the reduced formulation, and combine several quantities of interest. Finally, we present a numerical example with p = 10.},
year = {2019}
}

// Please update with existing arXiv entry already available on publication list
@Article{EndtNeiLaWiWo20,
title = "Multigoal-oriented optimal control problems with nonlinear PDE constraints",
journal = "Computers {&} Mathematics with Applications",
volume = "79",
number = "10",
pages = "3001 - 3026",
year = "2020",
issn = "0898-1221",
doi = "https://doi.org/10.1016/j.camwa.2020.01.005",
url = "http://www.sciencedirect.com/science/article/pii/S0898122120300122",
author = "B. Endtmayer and U. Langer and I. Neitzel and T. Wick and W. Wollner",
keywords = "Optimal control, Multigoal-oriented a posteriori error estimation, Regularized -Laplacian, Dual-weighted residuals, Finite elements",
abstract = "In this work, we consider an optimal control problem subject to a nonlinear PDE constraint and apply it to a semi-linear monotone PDE and the regularized p-Laplace equation. To this end, a reduced unconstrained optimization problem in terms of the control variable is formulated. Based on the reduced approach, we then derive an a posteriori error representation and mesh adaptivity for multiple quantities of interest. All quantities are combined to one, and then the dual-weighted residual (DWR) method is applied to this combined functional. Furthermore, the estimator allows for balancing the discretization error and the nonlinear iteration error. These developments allow us to formulate an adaptive solution strategy, which is finally substantiated with the help of several numerical examples."
}

Add publication by Hebner and others

In investigating whether this thesis uses deal.II, https://www.proquest.com/docview/2757012322?fromopenview=true&pq-origsite=gscholar&parentSessionId=uIy4r1WBQ5jAzx52HgphdoY6eFjuJNB8l2aT52Gm1d8%3D, I found that Hebner has a publications that uses deal.II:
https://www.science.org/doi/full/10.1126/sciadv.ade1320#supplementary-materials

In the author contributions statement, it says "Computational study: K.K. and K.B.", which refers to Kevin Korner and Kaushik Bhattacharya. I've looked around for these a bit, but perhaps some more work will turn up something more for these two.

iHeart

Quarteroni's group has been publishing a ton of papers using iHeart (which uses deal.II). Here's a recent one:

https://arxiv.org/pdf/2208.09435.pdf (EDIT: now part of the publication list)

I think we only have three of these in the repository so far.

Add these papers

@ARTICLE{Freddi2018573,

author={Freddi, F. and Sacco, E. and Serpieri, R.},

title={An enriched damage-frictional cohesive-zone model incorporating stress multi-axiality},

journal={Meccanica},

year={2018},

volume={53},

number={3},

pages={573-592},

}



@ARTICLE{Bonetti2019977,

author={Bonetti, E. and Cavaterra, C. and Freddi, F. and Grasselli, M. and Natalini, R.},

title={A nonlinear model for marble sulphation including surface rugosity: Theoretical and numerical results},

journal={Communications on Pure and Applied Analysis},

year={2019},

volume={18},

number={2},

pages={977-998},

}




@ARTICLE{Freddi201929,

author={Freddi, F.},

title={Fracture energy in phase field models},

journal={Mechanics Research Communications},

year={2019},

volume={96},

pages={29-36},

}

New items

Dear all
some further input from geosciences:

@Article{dambly2023insights,
author = {Dambly, M. L. T. and Samrock, F. and Grayver, A. V. and Saar, M. O.},
title = {Insights on the Interplay of Rifting, Transcrustal Magmatism and Formation of Geothermal Resources in the Central Segment of the Ethiopian Rift Revealed by 3-D Magnetotelluric Imaging},
journal = {Journal of Geophysical Research: Solid Earth},
volume = {128},
number = {7},
pages = {e2022JB025849},
doi = {https://doi.org/10.1029/2022JB025849},
year = {2023}
}

@Article{samrock2023geophysically,
title={Geophysically guided well siting at the Aluto-Langano geothermal reservoir},
author={Samrock, Friedemann and Grayver, Alexander and Dambly, Marie Luise Texas and M{"u}ller, Madeleine R and Saar, Martin},
journal={Geophysics},
volume={88},
number={5},
pages={1--43},
year={2023},
publisher={Society of Exploration Geophysicists}
}

Some more fun. The deal.II-enabled VTU model files were imported into Blender and used to create nice illustrations below.

Aluto

Matrix-free paper missing from regular entries

We need to add

M. Kronbichler, K. Kormann
A generic interface for parallel cell-based finite element operator application
Computers and Fluids, vol. 63, pp. 135-147, 2012.
DOI: 10.1016/j.compfluid.2012.04.012

to the list of publications. (It's in the "Publications on details of deal.II", but not the regular list.)

Response to deal.II publications list update request

Here is the bibtex entry as requested:

@Article{AGGUL2022115052,
title = {NS-ω model for fluid–fluid interaction problems at high Reynolds numbers},
journal = {Computer Methods in Applied Mechanics and Engineering},
volume = {395},
pages = {115052},
year = {2022},
issn = {0045-7825},
doi = {https://doi.org/10.1016/j.cma.2022.115052},
url = {https://www.sciencedirect.com/science/article/pii/S0045782522002663},
author = {Mustafa Aggul and Alexander E. Labovsky and Kyle J. Schwiebert},
}

Alternatively, the work can also be found here.

Remove artefacts from JabRef

We could remove the "owner" and "timestamp" fields in the current database. These were generated when the database was first created, and serve no real purpose here.

More publications

  1. S. Shiozawa*, S. Lee, M.F. Wheeler
    The effect of stress boundary conditions on fluid-driven fracture propagation in porous media using a phase field modeling approach,
    2019, International Journal for Numerical and Analytical Methods in Geomechanics, DOI: 10.1002/nag.2899

  2. J.Choo*, S. Lee
    Enriched Galerkin Finite Element Method for Locally Mass Conservative Simulation of Coupled Hydromechanical Problems
    2018, Proceedings of China-Europe Conference on Geotehcnical Engineering, Springer Nature Switzerland AG

  3. J. Choo*, S.Lee
    Enriched Galerkin finite elements for coupled poromechanics with local mass conservation,
    2018 November, Volume 341, Pages 311-332 Computer Methods in Applied Mechanics and Engineering

  4. S. Lee*, M. F. Wheeler
    Enriched Galerkin approximations for two phase flow in porous media with capillary pressure,
    2018, Volume 367, 15 August 2018, Pages 65-86, https://doi.org/10.1016/j.jcp.2018.03.031, Journal of Computational Physics

  5. S. Lee*, A. Mikelic, M. F. Wheeler, T. Wick
    Phase-field modeling of two phase fluid-filled fractures in a poroelastic medium,
    2018, 16-4, pp. 1542-1580, https://doi.org/10.1137/17M1145239, SIAM Multiscale Modeling and Simulation

  6. S. Lee, B. Min*, M. F. Wheeler
    Optimal hydraulic fracturing design using the phase field model coupled with global-objective genetic algorithm,
    2018, Volume 22, Issue 3, pp 833-849, Computational Geosciences, doi:10.1007/s10596-018-9728-6

  7. Rencheng Dong*, M.F. Wheeler, S. Lee
    Numerical Simulation of Matrix Acidizing in Fractured Carbonate Reservoirs Using Adaptive Enriched Galerkin Method
    2019, SPE-193862-MS, SPE RSC 2019, https://doi.org/10.2118/193862-MS

  8. M.F. Wheeler*, S. Srinivasan, S. Lee, M. Singh
    Unconventional Reservoir Management Modeling Coupling Diffusive Zone/Phase Field Fracture Modeling and Fracture Probability Maps,
    2019, SPE 193830-MS, SPE RSC 2019, https://doi.org/10.2118/193830-MS

  9. W. Choi, S. Lee*
    Optimal Error Estimate of Elliptic Problems with Dirac Sources,
    2019, submitted

Ah, here is the bibtex

@inproceedings{dong2019numerical,
title={Numerical Simulation of Matrix Acidizing in Fractured Carbonate Reservoirs Using Adaptive Enriched Galerkin Method},
author={Dong, Rencheng and Lee, Sanghyun and Wheeler, Mary and others},
booktitle={SPE Reservoir Simulation Conference},
year={2019},
organization={Society of Petroleum Engineers}
}

@inproceedings{wheeler2019unconventional,
title={Unconventional Reservoir Management Modeling Coupling Diffusive Zone/Phase Field Fracture Modeling and Fracture Probability Maps},
author={Wheeler, Mary F and Srinivasan, Sanjay and Lee, Sanghyun and Singh, Manik and others},
booktitle={SPE Reservoir Simulation Conference},
year={2019},
organization={Society of Petroleum Engineers}
}

@Article{doi:10.1002/nag.2899,
author = {Shiozawa, Sogo and Lee, Sanghyun and Wheeler, Mary F.},
title = {The effect of stress boundary conditions on fluid-driven fracture propagation in porous media using a phase-field modeling approach},
journal = {International Journal for Numerical and Analytical Methods in Geomechanics},
volume = {43},
year = {2019},
number = {6},
pages = {1316-1340},
keywords = {fluid-driven fracture, phase field, porous media, stress boundary conditions},
doi = {10.1002/nag.2899},
url = {https://onlinelibrary.wiley.com/doi/abs/10.1002/nag.2899},
eprint = {https://onlinelibrary.wiley.com/doi/pdf/10.1002/nag.2899},
abstract = {Summary A phase-field approach for fluid-driven fracture propagation in porous media with varying constant compatible stress boundary conditions is discussed and implemented. Since crack opening displacement, fracture path, and stress values near the fracture are highly dependent on the given boundary conditions, it is crucial to take into account the impact of in situ stresses on fracturing propagation for realistic applications. We illustrate several numerical examples that include the effects of different boundary conditions on the fracture propagation. In addition, an example using realistic boundary conditions from a reservoir simulator is included to show the capabilities of our computational framework.}
}
@Article{choo2018enriched,
title={Enriched Galerkin finite elements for coupled poromechanics with local mass conservation},
author={Choo, Jinhyun and Lee, Sanghyun},
journal={Computer Methods in Applied Mechanics and Engineering},
volume={341},
pages={311--332},
year={2018}
}

@inproceedings{choo2018enriched,
title={Enriched Galerkin Finite Element Method for Locally Mass Conservative Simulation of Coupled Hydromechanical Problems},
author={Choo, Jinhyun and Lee, Sanghyun},
booktitle={Proceedings of China-Europe Conference on Geotechnical Engineering},
pages={312--315},
year={2018},
organization={Springer}
}

@Article{lee2018enriched,
title={Enriched Galerkin methods for two-phase flow in porous media with capillary pressure},
author={Lee, Sanghyun and Wheeler, Mary F},
journal={Journal of Computational Physics},
volume={367},
pages={65--86},
year={2018},
publisher={Elsevier}
}

@Article{lee2018optimal,
title={Optimal design of hydraulic fracturing in porous media using the phase field fracture model coupled with genetic algorithm},
author={Lee, Sanghyun and Min, Baehyun and Wheeler, Mary F},
journal={Computational Geosciences},
volume={22},
number={3},
pages={833--849},
year={2018},
publisher={Springer International Publishing}
}

@Article{lee2018phase,
title={Phase-field modeling of two phase fluid filled fractures in a poroelastic medium},
author={Lee, Sanghyun and Mikelic, Andro and Wheeler, Mary F and Wick, Thomas},
journal={Multiscale Modeling & Simulation},
volume={16},
number={4},
pages={1542--1580},
year={2018},
publisher={Society for Industrial and Applied Mathematics}
}

Recommend Projects

  • React photo React

    A declarative, efficient, and flexible JavaScript library for building user interfaces.

  • Vue.js photo Vue.js

    🖖 Vue.js is a progressive, incrementally-adoptable JavaScript framework for building UI on the web.

  • Typescript photo Typescript

    TypeScript is a superset of JavaScript that compiles to clean JavaScript output.

  • TensorFlow photo TensorFlow

    An Open Source Machine Learning Framework for Everyone

  • Django photo Django

    The Web framework for perfectionists with deadlines.

  • D3 photo D3

    Bring data to life with SVG, Canvas and HTML. 📊📈🎉

Recommend Topics

  • javascript

    JavaScript (JS) is a lightweight interpreted programming language with first-class functions.

  • web

    Some thing interesting about web. New door for the world.

  • server

    A server is a program made to process requests and deliver data to clients.

  • Machine learning

    Machine learning is a way of modeling and interpreting data that allows a piece of software to respond intelligently.

  • Game

    Some thing interesting about game, make everyone happy.

Recommend Org

  • Facebook photo Facebook

    We are working to build community through open source technology. NB: members must have two-factor auth.

  • Microsoft photo Microsoft

    Open source projects and samples from Microsoft.

  • Google photo Google

    Google ❤️ Open Source for everyone.

  • D3 photo D3

    Data-Driven Documents codes.