get rid of some non-ASCII characters

This commit is contained in:
Axel Kohlmeyer
2024-09-25 22:00:21 -04:00
parent 385a0da892
commit c6fdd8ddb6
48 changed files with 71 additions and 75 deletions

View File

@ -918,15 +918,15 @@ int PairOxdnaExcv::pack_forward_comm(int n, int *list, double *buf,
m = 0; m = 0;
for (i = 0; i < n; i++) { for (i = 0; i < n; i++) {
j = list[i]; j = list[i];
buf[m++] = nx[j][0]; buf[m++] = nx[j][0];
buf[m++] = nx[j][1]; buf[m++] = nx[j][1];
buf[m++] = nx[j][2]; buf[m++] = nx[j][2];
buf[m++] = ny[j][0]; buf[m++] = ny[j][0];
buf[m++] = ny[j][1]; buf[m++] = ny[j][1];
buf[m++] = ny[j][2]; buf[m++] = ny[j][2];
buf[m++] = nz[j][0]; buf[m++] = nz[j][0];
buf[m++] = nz[j][1]; buf[m++] = nz[j][1];
buf[m++] = nz[j][2]; buf[m++] = nz[j][2];
} }
return m; return m;
} }
@ -936,19 +936,18 @@ int PairOxdnaExcv::pack_forward_comm(int n, int *list, double *buf,
void PairOxdnaExcv::unpack_forward_comm(int n, int first, double *buf) void PairOxdnaExcv::unpack_forward_comm(int n, int first, double *buf)
{ {
int i,m,last; int i,m,last;
m = 0; m = 0;
last = first + n; last = first + n;
for (i = first; i < last; i++) { for (i = first; i < last; i++) {
nx[i][0] = buf[m++]; nx[i][0] = buf[m++];
nx[i][1] = buf[m++]; nx[i][1] = buf[m++];
nx[i][2] = buf[m++]; nx[i][2] = buf[m++];
ny[i][0] = buf[m++]; ny[i][0] = buf[m++];
ny[i][1] = buf[m++]; ny[i][1] = buf[m++];
ny[i][2] = buf[m++]; ny[i][2] = buf[m++];
nz[i][0] = buf[m++]; nz[i][0] = buf[m++];
nz[i][1] = buf[m++]; nz[i][1] = buf[m++];
nz[i][2] = buf[m++]; nz[i][2] = buf[m++];
} }
} }

View File

@ -13,7 +13,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Martin Svoboda (ICPF, UJEP), Martin Lísal (ICPF, UJEP) Contributing authors: Martin Svoboda (ICPF, UJEP), Martin Lisal (ICPF, UJEP)
based on pair style dpd by: Kurt Smith (U Pittsburgh) based on pair style dpd by: Kurt Smith (U Pittsburgh)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */

View File

@ -13,7 +13,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Martin Svoboda (ICPF, UJEP), Martin Lísal (ICPF, UJEP) Contributing authors: Martin Svoboda (ICPF, UJEP), Martin Lisal (ICPF, UJEP)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "pair_dpd_ext_tstat.h" #include "pair_dpd_ext_tstat.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "boundary_correction.h" #include "boundary_correction.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifndef LMP_BOUNDARY_CORRECTION_H #ifndef LMP_BOUNDARY_CORRECTION_H

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifndef LMP_ELECTRODE_KSPACE_H #ifndef LMP_ELECTRODE_KSPACE_H

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifndef LMP_ELECTRODE_MATH_H #ifndef LMP_ELECTRODE_MATH_H

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "electrode_matrix.h" #include "electrode_matrix.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifndef LMP_ELECTRODE_MATRIX_H #ifndef LMP_ELECTRODE_MATRIX_H

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "electrode_vector.h" #include "electrode_vector.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifndef LMP_ELECTRODE_VECTOR_H #ifndef LMP_ELECTRODE_VECTOR_H

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "ewald_electrode.h" #include "ewald_electrode.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifdef KSPACE_CLASS #ifdef KSPACE_CLASS

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "fix_electrode_conp.h" #include "fix_electrode_conp.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifdef FIX_CLASS #ifdef FIX_CLASS

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "fix_electrode_conq.h" #include "fix_electrode_conq.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifdef FIX_CLASS #ifdef FIX_CLASS

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "fix_electrode_thermo.h" #include "fix_electrode_thermo.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifdef FIX_CLASS #ifdef FIX_CLASS

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "pppm_electrode.h" #include "pppm_electrode.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifdef KSPACE_CLASS #ifdef KSPACE_CLASS

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "slab_2d.h" #include "slab_2d.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifndef LMP_SLAB_2D_H #ifndef LMP_SLAB_2D_H

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "slab_dipole.h" #include "slab_dipole.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifndef LMP_SLAB_DIPOLE_H #ifndef LMP_SLAB_DIPOLE_H

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "wire_dipole.h" #include "wire_dipole.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meißner (TUHH) Contributing authors: Ludwig Ahrens-Iwers (TUHH), Shern Tee (UQ), Robert Meissner (TUHH)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#ifndef LMP_WIRE_DIPOLE_H #ifndef LMP_WIRE_DIPOLE_H

View File

@ -18,7 +18,7 @@ using namespace LAMMPS_NS;
* *
* Copyright: * Copyright:
* (C) 2012 Massachusetts Institute of Technology * (C) 2012 Massachusetts Institute of Technology
* (C) 2013 Forschungszentrum Jülich GmbH * (C) 2013 Forschungszentrum Juelich GmbH
* *
* Licence: * Licence:
* Permission is hereby granted, free of charge, to any person obtaining * Permission is hereby granted, free of charge, to any person obtaining
@ -42,7 +42,7 @@ using namespace LAMMPS_NS;
* *
* Authors: * Authors:
* Steven G. Johnson, Massachusetts Institute of Technology, 2012, core author * Steven G. Johnson, Massachusetts Institute of Technology, 2012, core author
* Joachim Wuttke, Forschungszentrum Jülich, 2013, package maintainer * Joachim Wuttke, Forschungszentrum Juelich, 2013, package maintainer
* *
* Website: * Website:
* https://jugit.fz-juelich.de/mlz/libcerf * https://jugit.fz-juelich.de/mlz/libcerf

View File

@ -13,7 +13,7 @@
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing author: Ajinkya Hire (Univ. of Florida), Contributing author: Ajinkya Hire (Univ. of Florida),
Hendrik Kraß (Univ. of Constance), Hendrik Krass (Univ. of Constance),
Matthias Rupp (Luxembourg Institute of Science and Technology), Matthias Rupp (Luxembourg Institute of Science and Technology),
Richard Hennig (Univ of Florida) Richard Hennig (Univ of Florida)
---------------------------------------------------------------------- */ ---------------------------------------------------------------------- */

View File

@ -13,7 +13,7 @@
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing author: Ajinkya Hire (Univ. of Florida), Contributing author: Ajinkya Hire (Univ. of Florida),
Hendrik Kraß (Univ. of Constance), Hendrik Krass (Univ. of Constance),
Matthias Rupp (Luxembourg Institute of Science and Technology), Matthias Rupp (Luxembourg Institute of Science and Technology),
Richard Hennig (Univ of Florida) Richard Hennig (Univ of Florida)
---------------------------------------------------------------------- */ ---------------------------------------------------------------------- */

View File

@ -13,7 +13,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing author: Dominik Wójt (Wroclaw University of Technology) Contributing author: Dominik Wojt (Wroclaw University of Technology)
based on pair_airebo by Ase Henry (MIT) based on pair_airebo by Ase Henry (MIT)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing author: Sebastian Hütter (OvGU) Contributing author: Sebastian Huetter (OvGU)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "meam.h" #include "meam.h"

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing author: Sebastian Hütter (OvGU) Contributing author: Sebastian Huetter (OvGU)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "meam.h" #include "meam.h"

View File

@ -40,7 +40,7 @@ using namespace FixConst;
* Please cite: * Please cite:
* Ceriotti, M., More, J., & Manolopoulos, D. E. (2014). * Ceriotti, M., More, J., & Manolopoulos, D. E. (2014).
* i-PI: A Python interface for ab initio path integral molecular dynamics simulations. * i-PI: A Python interface for ab initio path integral molecular dynamics simulations.
* Computer Physics Communications, 185, 10191026. doi:10.1016/j.cpc.2013.10.027 * Computer Physics Communications, 185, 1019-1026. doi:10.1016/j.cpc.2013.10.027
* And see [https://github.com/i-pi/i-pi] to download a version of i-PI * And see [https://github.com/i-pi/i-pi] to download a version of i-PI
******************************************************************************************/ ******************************************************************************************/

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing author: Pedro Antonio Santos Flórez (UNLV) Contributing author: Pedro Antonio Santos Florez (UNLV)
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
#include "mliap_model_nn.h" #include "mliap_model_nn.h"

View File

@ -1580,8 +1580,8 @@ double SNA::compute_dsfac(double r, double rcut, double sinner, double dinner)
else if (r <= rmin0) sfac_outer = 1.0; else if (r <= rmin0) sfac_outer = 1.0;
else if (r > rcut) sfac_outer = 0.0; else if (r > rcut) sfac_outer = 0.0;
else { else {
double rcutfac = MY_PI / (rcut - rmin0); double rcutfac = MY_PI / (rcut - rmin0);
sfac_outer = 0.5 * (cos((r - rmin0) * rcutfac) + 1.0); sfac_outer = 0.5 * (cos((r - rmin0) * rcutfac) + 1.0);
} }
// calculate sfac_inner // calculate sfac_inner

View File

@ -13,7 +13,7 @@
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing author: Ajinkya Hire (Univ. of Florida), Contributing author: Ajinkya Hire (Univ. of Florida),
Hendrik Kraß (Univ. of Constance), Hendrik Krass (Univ. of Constance),
Matthias Rupp (Luxembourg Institute of Science and Technology), Matthias Rupp (Luxembourg Institute of Science and Technology),
Richard Hennig (Univ of Florida) Richard Hennig (Univ of Florida)
---------------------------------------------------------------------- */ ---------------------------------------------------------------------- */

View File

@ -13,7 +13,7 @@
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing author: Ajinkya Hire (Univ. of Florida), Contributing author: Ajinkya Hire (Univ. of Florida),
Hendrik Kraß (Univ. of Constance), Hendrik Krass (Univ. of Constance),
Matthias Rupp (Luxembourg Institute of Science and Technology), Matthias Rupp (Luxembourg Institute of Science and Technology),
Richard Hennig (Univ of Florida) Richard Hennig (Univ of Florida)
---------------------------------------------------------------------- */ ---------------------------------------------------------------------- */

View File

@ -844,7 +844,7 @@ void FixBondReact::init_list(int /*id*/, NeighList *ptr)
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Identify all pairs of potentially reactive atoms for this time step. Identify all pairs of potentially reactive atoms for this time step.
This function is modified from LAMMPS fix bond/create. This function is modified from LAMMPS' fix bond/create.
---------------------------------------------------------------------- */ ---------------------------------------------------------------------- */
void FixBondReact::post_integrate() void FixBondReact::post_integrate()

View File

@ -14,7 +14,7 @@
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
The SMTBQ code has been developed with the financial support of CNRS and The SMTBQ code has been developed with the financial support of CNRS and
of the Regional Council of Burgundy (Convention 2010-9201AAO037S03129) of the Regional Council of Burgundy (Convention No 2010-9201AAO037S03129)
Copyright (2015) Copyright (2015)
Universite de Bourgogne : Nicolas SALLES, Olivier POLITANO Universite de Bourgogne : Nicolas SALLES, Olivier POLITANO
@ -27,7 +27,7 @@
Contact: Nicolas Salles <nsalles33@gmail.com> Contact: Nicolas Salles <nsalles33@gmail.com>
Olivier Politano <olivier.politano@u-bourgogne.fr> Olivier Politano <olivier.politano@u-bourgogne.fr>
Robert Tétot <robert.tetot@universite-paris-saclay.fr> Robert Tetot <robert.tetot@universite-paris-saclay.fr>
This program is free software; you can redistribute it and/or This program is free software; you can redistribute it and/or
modify it under the terms of the GNU General Public License as modify it under the terms of the GNU General Public License as
@ -895,7 +895,7 @@ void PairSMTBQ::compute(int eflag, int vflag)
3 -> Short int. Ox-Ox 3 -> Short int. Ox-Ox
4 -> Short int. SMTB (repulsion) 4 -> Short int. SMTB (repulsion)
5 -> Covalent energy SMTB 5 -> Covalent energy SMTB
6 -> Somme des Q(i)² 6 -> Sum over Q(i)**2
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* -------------- N-body forces Calcul --------------- */ /* -------------- N-body forces Calcul --------------- */
@ -2980,9 +2980,6 @@ void PairSMTBQ::groupQEqAllParallel_QEq()
ngp = igp = 0; nelt[ngp] = 0; ngp = igp = 0; nelt[ngp] = 0;
// On prend un oxygène
// printf ("[me %d] On prend un oxygene\n",me);
for (ii = 0; ii < inum; ii++) { for (ii = 0; ii < inum; ii++) {
i = ilist[ii] ; itype = map[type[i]]; i = ilist[ii] ; itype = map[type[i]];
if (itype != 0 || flag_QEq[i] == 0) continue; if (itype != 0 || flag_QEq[i] == 0) continue;

View File

@ -292,7 +292,7 @@ double PairSPHLJ::init_one(int i, int j)
/* --------------------------------------------------------------------------------------------- */ /* --------------------------------------------------------------------------------------------- */
/* Lennard-Jones EOS, /* Lennard-Jones EOS,
Francis H. Ree Francis H. Ree
"Analytic representation of thermodynamic data for the LennardJones fluid", Analytic representation of thermodynamic data for the Lennard-Jones fluid,
Journal of Chemical Physics 73 pp. 5401-5403 (1980) Journal of Chemical Physics 73 pp. 5401-5403 (1980)
*/ */
@ -331,7 +331,7 @@ void PairSPHLJ::LJEOS2(double rho, double e, double cv, double *p, double *c)
/* ------------------------------------------------------------------------------ */ /* ------------------------------------------------------------------------------ */
/* Jirí Kolafa, Ivo Nezbeda /* Jiri Kolafa, Ivo Nezbeda
* "The Lennard-Jones fluid: an accurate analytic and theoretically-based equation of state", * "The Lennard-Jones fluid: an accurate analytic and theoretically-based equation of state",
* Fluid Phase Equilibria 100 pp. 1-34 (1994) */ * Fluid Phase Equilibria 100 pp. 1-34 (1994) */
/*double PairSPHLJ::LJEOS2(double rho, double e, double cv) { /*double PairSPHLJ::LJEOS2(double rho, double e, double cv) {

View File

@ -16,7 +16,7 @@
Contributing authors: Julien Tranchida (SNL) Contributing authors: Julien Tranchida (SNL)
Please cite the related publication: Please cite the related publication:
Bessarab, P. F., Uzdin, V. M., & Jónsson, H. (2015). Bessarab, P. F., Uzdin, V. M., & Jonsson, H. (2015).
Method for finding mechanism and activation energy of magnetic transitions, Method for finding mechanism and activation energy of magnetic transitions,
applied to skyrmion and antivortex annihilation. applied to skyrmion and antivortex annihilation.
Computer Physics Communications, 196, 335-347. Computer Physics Communications, 196, 335-347.

View File

@ -17,7 +17,7 @@
Julien Tranchida (SNL) Julien Tranchida (SNL)
Please cite the related publication: Please cite the related publication:
Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust Ivanov, A. V., Uzdin, V. M., & Jonsson, H. (2019). Fast and Robust
Algorithm for the Minimisation of the Energy of Spin Systems. arXiv Algorithm for the Minimisation of the Energy of Spin Systems. arXiv
preprint arXiv:1904.02669. preprint arXiv:1904.02669.
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */

View File

@ -17,7 +17,7 @@
Julien Tranchida (SNL) Julien Tranchida (SNL)
Please cite the related publication: Please cite the related publication:
Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust Ivanov, A. V., Uzdin, V. M., & Jonsson, H. (2019). Fast and Robust
Algorithm for the Minimisation of the Energy of Spin Systems. arXiv Algorithm for the Minimisation of the Energy of Spin Systems. arXiv
preprint arXiv:1904.02669. preprint arXiv:1904.02669.
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */

View File

@ -16,7 +16,7 @@
Contributing authors: Julien Tranchida (SNL) Contributing authors: Julien Tranchida (SNL)
Please cite the related publication: Please cite the related publication:
Bessarab, P. F., Uzdin, V. M., & Jónsson, H. (2015). Bessarab, P. F., Uzdin, V. M., & Jonsson, H. (2015).
Method for finding mechanism and activation energy of magnetic transitions, Method for finding mechanism and activation energy of magnetic transitions,
applied to skyrmion and antivortex annihilation. applied to skyrmion and antivortex annihilation.
Computer Physics Communications, 196, 335-347. Computer Physics Communications, 196, 335-347.

View File

@ -33,7 +33,7 @@ static const char cite_type_label_framework[] =
" year = 2024,\n" " year = 2024,\n"
" volume = 128,\n" " volume = 128,\n"
" number = 13,\n" " number = 13,\n"
" pages = {3282-3297}\n" " pages = {3282--3297}\n"
"}\n\n"; "}\n\n";
/* ---------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- */

View File

@ -209,7 +209,7 @@ double MathSpecial::factorial(const int n)
* *
* Copyright: * Copyright:
* (C) 2012 Massachusetts Institute of Technology * (C) 2012 Massachusetts Institute of Technology
* (C) 2013 Forschungszentrum Jülich GmbH * (C) 2013 Forschungszentrum Juelich GmbH
* *
* Licence: * Licence:
* Permission is hereby granted, free of charge, to any person obtaining * Permission is hereby granted, free of charge, to any person obtaining
@ -233,7 +233,7 @@ double MathSpecial::factorial(const int n)
* *
* Authors: * Authors:
* Steven G. Johnson, Massachusetts Institute of Technology, 2012, core author * Steven G. Johnson, Massachusetts Institute of Technology, 2012, core author
* Joachim Wuttke, Forschungszentrum Jülich, 2013, package maintainer * Joachim Wuttke, Forschungszentrum Juelich, 2013, package maintainer
* *
* Website: * Website:
* https://jugit.fz-juelich.de/mlz/libcerf * https://jugit.fz-juelich.de/mlz/libcerf

View File

@ -12,7 +12,7 @@
------------------------------------------------------------------------- */ ------------------------------------------------------------------------- */
/* ---------------------------------------------------------------------- /* ----------------------------------------------------------------------
Contributing authors: Julien Guénolé, CNRS and Contributing authors: Julien Guenole, CNRS and
Erik Bitzek, FAU Erlangen-Nuernberg Erik Bitzek, FAU Erlangen-Nuernberg
Support for ABC-FIRE: Support for ABC-FIRE: