From bbcfbe957bf0e81401cefb5ce3aa7cb773f98e91 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 12 Aug 2023 17:22:34 -0400 Subject: [PATCH] implement context specific help either via right-click or CTRL-? --- tools/lammps-gui/CMakeLists.txt | 2 +- tools/lammps-gui/TODO.md | 1 - tools/lammps-gui/codeeditor.cpp | 123 ++- tools/lammps-gui/codeeditor.h | 18 + tools/lammps-gui/help_index.table | 1443 +++++++++++++++++++++++++ tools/lammps-gui/lammpsgui.qrc | 24 +- tools/lammps-gui/lammpsgui.ui | 17 +- tools/lammps-gui/system-help.png | Bin 0 -> 2567 bytes tools/lammps-gui/update-help-index.sh | 4 + 9 files changed, 1618 insertions(+), 14 deletions(-) create mode 100644 tools/lammps-gui/help_index.table create mode 100644 tools/lammps-gui/system-help.png create mode 100755 tools/lammps-gui/update-help-index.sh diff --git a/tools/lammps-gui/CMakeLists.txt b/tools/lammps-gui/CMakeLists.txt index 863d7e424d..b7d7211c95 100644 --- a/tools/lammps-gui/CMakeLists.txt +++ b/tools/lammps-gui/CMakeLists.txt @@ -1,6 +1,6 @@ cmake_minimum_required(VERSION 3.16) -project(lammps-gui VERSION 1.1.7 LANGUAGES CXX) +project(lammps-gui VERSION 1.1.8 LANGUAGES CXX) set(CMAKE_AUTOUIC ON) set(CMAKE_AUTOMOC ON) diff --git a/tools/lammps-gui/TODO.md b/tools/lammps-gui/TODO.md index 7e634b2234..ad98b29c87 100644 --- a/tools/lammps-gui/TODO.md +++ b/tools/lammps-gui/TODO.md @@ -25,5 +25,4 @@ LAMMPS-GUI TODO list: - support single stepping, i.e. process input line by line (need to detect continuation chars!) with highlighting active line(s) - have command text input file in/above status bar where individual commands can be tested. have insert button to copy line into file at the current point - support text completion as done with lammps-shell -- have context menu for known commands to offer retrieving help by dispatching URL to webbrowser (process index from sphinx for that purpose) - add a "python" mode, where instead of launching LAMMPS, python is loaded that the LAMMPS python module is made available. diff --git a/tools/lammps-gui/codeeditor.cpp b/tools/lammps-gui/codeeditor.cpp index f0a375efc0..15dc022f87 100644 --- a/tools/lammps-gui/codeeditor.cpp +++ b/tools/lammps-gui/codeeditor.cpp @@ -15,19 +15,59 @@ #include "lammpsgui.h" #include "linenumberarea.h" +#include +#include #include #include +#include +#include +#include #include #include +#include #include +#include CodeEditor::CodeEditor(QWidget *parent) : QPlainTextEdit(parent) { - lineNumberArea = new LineNumberArea(this); + help_action = new QShortcut(QKeySequence::fromString("Ctrl+?"), parent); + connect(help_action, &QShortcut::activated, this, &CodeEditor::get_help); + // initialize help system + QFile help_index(":/help_index.table"); + if (help_index.open(QIODevice::ReadOnly | QIODevice::Text)) { + while (!help_index.atEnd()) { + auto line = QString(help_index.readLine()); + auto words = line.trimmed().split(' '); + if (words.size() > 2) { + if (words.at(1) == "pair_style") { + pair_map[words.at(2)] = words.at(0); + } else if (words.at(1) == "bond_style") { + bond_map[words.at(2)] = words.at(0); + } else if (words.at(1) == "angle_style") { + angle_map[words.at(2)] = words.at(0); + } else if (words.at(1) == "dihedral_style") { + dihedral_map[words.at(2)] = words.at(0); + } else if (words.at(1) == "improper_style") { + improper_map[words.at(2)] = words.at(0); + } else if (words.at(1) == "fix") { + fix_map[words.at(2)] = words.at(0); + } else if (words.at(1) == "compute") { + compute_map[words.at(2)] = words.at(0); + } + // ignoring: min_style, kspace_style, dump, fix_modify ATC + } else if (words.size() == 2) { + cmd_map[words.at(1)] = words.at(0); + } else { + fprintf(stderr, "unhandled: %s", line.toStdString().c_str()); + } + } + help_index.close(); + } + + lineNumberArea = new LineNumberArea(this); connect(this, &CodeEditor::blockCountChanged, this, &CodeEditor::updateLineNumberAreaWidth); connect(this, &CodeEditor::updateRequest, this, &CodeEditor::updateLineNumberArea); - updateLineNumberAreaWidth(0); } @@ -138,6 +178,85 @@ void CodeEditor::lineNumberAreaPaintEvent(QPaintEvent *event) } } +void CodeEditor::contextMenuEvent(QContextMenuEvent *event) +{ + // reposition the cursor here? + QString page, help; + find_help(page, help); + + // print augmented context menu if an entry was found + auto *menu = createStandardContextMenu(); + if (!page.isEmpty()) { + menu->addSeparator(); + auto action = menu->addAction(QString("Look up help for '%1'").arg(help)); + action->setIcon(QIcon(":/system-help.png")); + action->setData(page); + connect(action, &QAction::triggered, this, &CodeEditor::open_help); + } + menu->exec(event->globalPos()); + delete menu; +} + +void CodeEditor::get_help() +{ + QString page, help; + find_help(page, help); + if (!page.isEmpty()) + QDesktopServices::openUrl(QUrl(QString("https://docs.lammps.org/%1").arg(page))); +} + +void CodeEditor::find_help(QString &page, QString &help) +{ + // process line of text where the cursor is + auto text = textCursor().block().text().replace('\t', ' ').trimmed(); + auto style = + QRegularExpression("^(pair|bond|angle|dihedral|improper)_style\\s+(\\S+)").match(text); + help.clear(); + page.clear(); + if (style.hasMatch()) { + if (style.captured(1) == "pair") { + page = pair_map.value(style.captured(2), QString()); + help = QString("pair_style %1").arg(style.captured(2)); + } else if (style.captured(1) == "bond") { + page = bond_map.value(style.captured(2), QString()); + help = QString("bond_style %1").arg(style.captured(2)); + } else if (style.captured(1) == "angle") { + page = angle_map.value(style.captured(2), QString()); + help = QString("angle_style %1").arg(style.captured(2)); + } else if (style.captured(1) == "dihedral") { + page = dihedral_map.value(style.captured(2), QString()); + help = QString("dihedral_style %1").arg(style.captured(2)); + } else if (style.captured(1) == "improper") { + page = improper_map.value(style.captured(2), QString()); + help = QString("improper_style %1").arg(style.captured(2)); + } + } + + style = QRegularExpression("^(fix|compute)\\s+\\w+\\s+\\w+\\s+(\\S+)").match(text); + if (style.hasMatch()) { + help = QString("%1 %2").arg(style.captured(1), style.captured(2)); + if (style.captured(1) == "fix") { + page = fix_map.value(style.captured(2), QString()); + } else if (style.captured(1) == "compute") { + page = compute_map.value(style.captured(2), QString()); + } + } + + // could not find a matching "style", now try the plain command + if (page.isEmpty() && !text.isEmpty()) { + auto cmd = text.split(' ').at(0); + help = cmd; + page = cmd_map.value(cmd, QString()); + } +} + +void CodeEditor::open_help() +{ + QAction *act = qobject_cast(sender()); + QDesktopServices::openUrl( + QUrl(QString("https://docs.lammps.org/%1").arg(act->data().toString()))); +} + // Local Variables: // c-basic-offset: 4 // End: diff --git a/tools/lammps-gui/codeeditor.h b/tools/lammps-gui/codeeditor.h index 49abf81553..57cdd8576b 100644 --- a/tools/lammps-gui/codeeditor.h +++ b/tools/lammps-gui/codeeditor.h @@ -14,7 +14,10 @@ #ifndef CODEEDITOR_H #define CODEEDITOR_H +#include #include +#include +#include class CodeEditor : public QPlainTextEdit { Q_OBJECT @@ -30,14 +33,29 @@ protected: void dragEnterEvent(QDragEnterEvent *event) override; bool canInsertFromMimeData(const QMimeData *source) const override; void dropEvent(QDropEvent *event) override; + void contextMenuEvent(QContextMenuEvent *event) override; private slots: void updateLineNumberAreaWidth(int newBlockCount); void highlightCurrentLine(); void updateLineNumberArea(const QRect &rect, int dy); + void get_help(); + void find_help(QString &page, QString &help); + void open_help(); private: QWidget *lineNumberArea; + QShortcut *help_action; + + QMap cmd_map; + QMap fix_map; + QMap compute_map; + QMap pair_map; + QMap bond_map; + QMap angle_map; + QMap dihedral_map; + QMap improper_map; + QMap dump_map; }; #endif diff --git a/tools/lammps-gui/help_index.table b/tools/lammps-gui/help_index.table new file mode 100644 index 0000000000..d32483760a --- /dev/null +++ b/tools/lammps-gui/help_index.table @@ -0,0 +1,1443 @@ +angle_amoeba.html angle_style amoeba +angle_charmm.html angle_style charmm +angle_charmm.html angle_style charmm/intel +angle_charmm.html angle_style charmm/kk +angle_charmm.html angle_style charmm/omp +angle_class2.html angle_style class2 +angle_class2.html angle_style class2/kk +angle_class2.html angle_style class2/omp +angle_class2.html angle_style class2/p6 +angle_coeff.html angle_coeff +angle_cosine_buck6d.html angle_style cosine/buck6d +angle_cosine_delta.html angle_style cosine/delta +angle_cosine_delta.html angle_style cosine/delta/omp +angle_cosine_periodic.html angle_style cosine/periodic +angle_cosine_periodic.html angle_style cosine/periodic/omp +angle_cosine.html angle_style cosine +angle_cosine.html angle_style cosine/kk +angle_cosine.html angle_style cosine/omp +angle_cosine_shift_exp.html angle_style cosine/shift/exp +angle_cosine_shift_exp.html angle_style cosine/shift/exp/omp +angle_cosine_shift.html angle_style cosine/shift +angle_cosine_shift.html angle_style cosine/shift/omp +angle_cosine_squared.html angle_style cosine/squared +angle_cosine_squared.html angle_style cosine/squared/omp +angle_cross.html angle_style cross +angle_dipole.html angle_style dipole +angle_dipole.html angle_style dipole/omp +angle_fourier.html angle_style fourier +angle_fourier.html angle_style fourier/omp +angle_fourier_simple.html angle_style fourier/simple +angle_fourier_simple.html angle_style fourier/simple/omp +angle_gaussian.html angle_style gaussian +angle_harmonic.html angle_style harmonic +angle_harmonic.html angle_style harmonic/intel +angle_harmonic.html angle_style harmonic/kk +angle_harmonic.html angle_style harmonic/omp +angle_hybrid.html angle_style hybrid +angle_lepton.html angle_style lepton +angle_lepton.html angle_style lepton/omp +angle_mesocnt.html angle_style mesocnt +angle_mm3.html angle_style mm3 +angle_none.html angle_style none +angle_quartic.html angle_style quartic +angle_quartic.html angle_style quartic/omp +angle_spica.html angle_style spica +angle_spica.html angle_style spica/omp +angle_style.html angle_style +angle_table.html angle_style table +angle_table.html angle_style table/omp +angle_write.html angle_write +angle_zero.html angle_style zero +atc_add_molecule.html fix_modify AtC add_molecule +atc_add_species.html fix_modify AtC add_species +atc_atom_element_map.html fix_modify AtC atom_element_map +atc_atomic_charge.html fix_modify AtC atomic_charge +atc_atom_weight.html fix_modify AtC atom_weight +atc_boundary_dynamics.html fix_modify AtC boundary_dynamics +atc_boundary_faceset.html fix_modify AtC boundary_faceset +atc_boundary_type.html fix_modify AtC boundary type +atc_consistent_fe_initialization.html fix_modify AtC consistent_fe_initialization +atc_control_localized_lambda.html fix_modify AtC control localized_lambda +atc_control_momentum.html fix_modify AtC control momentum +atc_control_thermal.html fix_modify AtC control thermal +atc_decomposition.html fix_modify AtC decomposition +atc_electron_integration.html fix_modify AtC extrinsic electron_integration +atc_equilibrium_start.html fix_modify AtC equilibrium_start +atc_extrinsic_exchange.html fix_modify AtC extrinsic exchange +atc_fe_md_boundary.html fix_modify AtC fe_md_boundary +atc_filter_scale.html fix_modify AtC filter scale +atc_filter_type.html fix_modify AtC filter type +atc_fix_flux.html fix_modify AtC fix_flux +atc_fix.html fix_modify AtC fix +atc_hardy_computes.html fix_modify AtC computes +atc_hardy_fields.html fix_modify AtC fields +atc_hardy_gradients.html fix_modify AtC gradients +atc_hardy_kernel.html fix_modify AtC kernel +atc_hardy_on_the_fly.html fix_modify AtC on_the_fly +atc_hardy_rates.html fix_modify AtC rates +atc_initial.html fix_modify AtC initial +atc_internal_element_set.html fix_modify AtC internal_element_set +atc_internal_quadrature.html fix_modify AtC internal_quadrature +atc_kernel_bandwidth.html fix_modify AtC kernel_bandwidth +atc_lumped_lambda_solve.html fix_modify AtC control lumped_lambda_solve +atc_mask_direction.html fix_modify AtC control mask_direction +atc_mass_matrix.html fix_modify AtC mass_matrix +atc_material.html fix_modify AtC material +atc_mesh_add_to_nodeset.html fix_modify AtC mesh add_to_nodeset +atc_mesh_create_elementset.html fix_modify AtC mesh create_elementset +atc_mesh_create_faceset_box.html fix_modify AtC mesh create_faceset box +atc_mesh_create_faceset_plane.html fix_modify AtC mesh create_faceset plane +atc_mesh_create_nodeset.html fix_modify AtC mesh create_nodeset +atc_mesh_create.html fix_modify AtC mesh create +atc_mesh_delete_elements.html fix_modify AtC mesh delete_elements +atc_mesh_nodeset_to_elementset.html fix_modify AtC mesh nodeset_to_elementset +atc_mesh_output.html fix_modify AtC mesh output +atc_mesh_quadrature.html fix_modify AtC mesh quadrature +atc_mesh_read.html fix_modify AtC mesh read +atc_mesh_write.html fix_modify AtC mesh write +atc_output_boundary_integral.html fix_modify AtC output boundary_integral +atc_output_contour_integral.html fix_modify AtC output contour_integral +atc_output_nodeset.html fix_modify AtC output nodeset +atc_output.html fix_modify AtC output +atc_output_volume_integral.html fix_modify AtC output volume_integral +atc_pair_interactions.html fix_modify AtC pair_interactions +atc_poisson_solver.html fix_modify AtC poisson_solver +atc_read_restart.html fix_modify AtC read_restart +atc_remove_molecule.html fix_modify AtC remove_molecule +atc_remove_source.html fix_modify AtC remove_source +atc_remove_species.html fix_modify AtC remove_species +atc_reset_atomic_reference.html fix_modify AtC reset_atomic_reference_positions +atc_reset_time.html fix_modify AtC reset_time +atc_sample_frequency.html fix_modify AtC sample_frequency +atc_set_reference_pe.html fix_modify AtC set reference_potential_energy +atc_source_integration.html fix_modify AtC source_integration +atc_source.html fix_modify AtC source +atc_temperature_definition.html fix_modify AtC temperature_definition +atc_time_filter.html fix_modify AtC filter +atc_time_integration.html fix_modify AtC time_integration +atc_track_displacement.html fix_modify AtC track_displacement +atc_unfix_flux.html fix_modify AtC unfix_flux +atc_unfix.html fix_modify AtC unfix +atc_write_atom_weights.html fix_modify AtC write_atom_weights +atc_write_restart.html fix_modify AtC write_restart +atom_modify.html atom_modify +atom_style.html atom_style +balance.html balance +bond_bpm_rotational.html bond_style bpm/rotational +bond_bpm_spring.html bond_style bpm/spring +bond_class2.html bond_style class2 +bond_class2.html bond_style class2/kk +bond_class2.html bond_style class2/omp +bond_coeff.html bond_coeff +bond_fene_expand.html bond_style fene/expand +bond_fene_expand.html bond_style fene/expand/omp +bond_fene.html bond_style fene +bond_fene.html bond_style fene/intel +bond_fene.html bond_style fene/kk +bond_fene.html bond_style fene/nm +bond_fene.html bond_style fene/omp +bond_gaussian.html bond_style gaussian +bond_gromos.html bond_style gromos +bond_gromos.html bond_style gromos/omp +bond_harmonic_restrain.html bond_style harmonic/restrain +bond_harmonic.html bond_style harmonic +bond_harmonic.html bond_style harmonic/intel +bond_harmonic.html bond_style harmonic/kk +bond_harmonic.html bond_style harmonic/omp +bond_harmonic_shift_cut.html bond_style harmonic/shift/cut +bond_harmonic_shift_cut.html bond_style harmonic/shift/cut/omp +bond_harmonic_shift.html bond_style harmonic/shift +bond_harmonic_shift.html bond_style harmonic/shift/omp +bond_hybrid.html bond_style hybrid +bond_lepton.html bond_style lepton +bond_lepton.html bond_style lepton/omp +bond_mesocnt.html bond_style mesocnt +bond_mm3.html bond_style mm3 +bond_morse.html bond_style morse +bond_morse.html bond_style morse/omp +bond_none.html bond_style none +bond_nonlinear.html bond_style nonlinear +bond_nonlinear.html bond_style nonlinear/omp +bond_oxdna.html bond_style oxdna2/fene +bond_oxdna.html bond_style oxdna/fene +bond_oxdna.html bond_style oxrna2/fene +bond_quartic.html bond_style quartic +bond_quartic.html bond_style quartic/omp +bond_special.html bond_style special +bond_style.html bond_style +bond_table.html bond_style table +bond_table.html bond_style table/omp +bond_write.html bond_write +bond_zero.html bond_style zero +boundary.html boundary +change_box.html change_box +clear.html clear +comm_modify.html comm_modify +comm_style.html comm_style +compute_ackland_atom.html compute ackland/atom +compute_adf.html compute adf +compute_angle_local.html compute angle/local +compute_angle.html compute angle +compute_angmom_chunk.html compute angmom/chunk +compute_ave_sphere_atom.html compute ave/sphere/atom +compute_ave_sphere_atom.html compute ave/sphere/atom/kk +compute_basal_atom.html compute basal/atom +compute_body_local.html compute body/local +compute_bond_local.html compute bond/local +compute_bond.html compute bond +compute_born_matrix.html compute born/matrix +compute_centro_atom.html compute centro/atom +compute_chunk_atom.html compute chunk/atom +compute_chunk_spread_atom.html compute chunk/spread/atom +compute_cluster_atom.html compute aggregate/atom +compute_cluster_atom.html compute cluster/atom +compute_cluster_atom.html compute fragment/atom +compute_cna_atom.html compute cna/atom +compute_cnp_atom.html compute cnp/atom +compute_com_chunk.html compute com/chunk +compute_com.html compute com +compute_contact_atom.html compute contact/atom +compute_coord_atom.html compute coord/atom +compute_coord_atom.html compute coord/atom/kk +compute_count_type.html compute count/type +compute_damage_atom.html compute damage/atom +compute_dihedral_local.html compute dihedral/local +compute_dihedral.html compute dihedral +compute_dilatation_atom.html compute dilatation/atom +compute_dipole_chunk.html compute dipole/chunk +compute_dipole_chunk.html compute dipole/tip4p/chunk +compute_dipole.html compute dipole +compute_dipole.html compute dipole/tip4p +compute_displace_atom.html compute displace/atom +compute_dpd_atom.html compute dpd/atom +compute_dpd.html compute dpd +compute_edpd_temp_atom.html compute edpd/temp/atom +compute_efield_atom.html compute efield/atom +compute_efield_wolf_atom.html compute efield/wolf/atom +compute_entropy_atom.html compute entropy/atom +compute_erotate_asphere.html compute erotate/asphere +compute_erotate_rigid.html compute erotate/rigid +compute_erotate_sphere_atom.html compute erotate/sphere/atom +compute_erotate_sphere.html compute erotate/sphere +compute_erotate_sphere.html compute erotate/sphere/kk +compute_event_displace.html compute event/displace +compute_fabric.html compute fabric +compute_fep.html compute fep +compute_fep_ta.html compute fep/ta +compute_global_atom.html compute global/atom +compute_group_group.html compute group/group +compute_gyration_chunk.html compute gyration/chunk +compute_gyration.html compute gyration +compute_gyration_shape_chunk.html compute gyration/shape/chunk +compute_gyration_shape.html compute gyration/shape +compute_heat_flux.html compute heat/flux +compute_hexorder_atom.html compute hexorder/atom +compute_hma.html compute hma +compute_improper_local.html compute improper/local +compute_improper.html compute improper +compute_inertia_chunk.html compute inertia/chunk +compute_ke_atom_eff.html compute ke/atom/eff +compute_ke_atom.html compute ke/atom +compute_ke_eff.html compute ke/eff +compute_ke_rigid.html compute ke/rigid +compute_ke.html compute ke +compute_local_comp_atom.html compute local/comp/atom +compute_local_comp_atom.html compute local/comp/atom/kk +compute_mliap.html compute mliap +compute_modify.html compute_modify +compute_momentum.html compute momentum +compute_msd_chunk.html compute msd/chunk +compute_msd_nongauss.html compute msd/nongauss +compute_msd.html compute msd +compute_nbond_atom.html compute nbond/atom +compute_omega_chunk.html compute omega/chunk +compute_orientorder_atom.html compute orientorder/atom +compute_orientorder_atom.html compute orientorder/atom/kk +compute_pair_local.html compute pair/local +compute_pair.html compute pair +compute_pe_atom.html compute pe/atom +compute_pe.html compute pe +compute_plasticity_atom.html compute plasticity/atom +compute_pressure_alchemy.html compute pressure/alchemy +compute_pressure.html compute pressure +compute_pressure_uef.html compute pressure/uef +compute_property_atom.html compute property/atom +compute_property_chunk.html compute property/chunk +compute_property_grid.html compute property/grid +compute_property_local.html compute property/local +compute_ptm_atom.html compute ptm/atom +compute_rdf.html compute rdf +compute_reduce_chunk.html compute reduce/chunk +compute_reduce.html compute reduce +compute_reduce.html compute reduce/region +compute_rigid_local.html compute rigid/local +compute.html compute +compute_saed.html compute saed +compute_slice.html compute slice +compute_smd_contact_radius.html compute smd/contact/radius +compute_smd_damage.html compute smd/damage +compute_smd_hourglass_error.html compute smd/hourglass/error +compute_smd_internal_energy.html compute smd/internal/energy +compute_smd_plastic_strain_rate.html compute smd/plastic/strain/rate +compute_smd_plastic_strain.html compute smd/plastic/strain +compute_smd_rho.html compute smd/rho +compute_smd_tlsph_defgrad.html compute smd/tlsph/defgrad +compute_smd_tlsph_dt.html compute smd/tlsph/dt +compute_smd_tlsph_num_neighs.html compute smd/tlsph/num/neighs +compute_smd_tlsph_shape.html compute smd/tlsph/shape +compute_smd_tlsph_strain_rate.html compute smd/tlsph/strain/rate +compute_smd_tlsph_strain.html compute smd/tlsph/strain +compute_smd_tlsph_stress.html compute smd/tlsph/stress +compute_smd_triangle_vertices.html compute smd/triangle/vertices +compute_smd_ulsph_effm.html compute smd/ulsph/effm +compute_smd_ulsph_num_neighs.html compute smd/ulsph/num/neighs +compute_smd_ulsph_strain_rate.html compute smd/ulsph/strain/rate +compute_smd_ulsph_strain.html compute smd/ulsph/strain +compute_smd_ulsph_stress.html compute smd/ulsph/stress +compute_smd_vol.html compute smd/vol +compute_sna_atom.html compute sna/atom +compute_sna_atom.html compute snad/atom +compute_sna_atom.html compute sna/grid +compute_sna_atom.html compute sna/grid/local +compute_sna_atom.html compute snap +compute_sna_atom.html compute snav/atom +compute_sph_e_atom.html compute sph/e/atom +compute_sph_rho_atom.html compute sph/rho/atom +compute_sph_t_atom.html compute sph/t/atom +compute_spin.html compute spin +compute_stress_atom.html compute centroid/stress/atom +compute_stress_atom.html compute stress/atom +compute_stress_cartesian.html compute stress/cartesian +compute_stress_curvilinear.html compute stress/cylinder +compute_stress_curvilinear.html compute stress/spherical +compute_stress_mop.html compute stress/mop +compute_stress_mop.html compute stress/mop/profile +compute_tally.html compute force/tally +compute_tally.html compute heat/flux/tally +compute_tally.html compute heat/flux/virial/tally +compute_tally.html compute pe/mol/tally +compute_tally.html compute pe/tally +compute_tally.html compute stress/tally +compute_tdpd_cc_atom.html compute tdpd/cc/atom +compute_temp_asphere.html compute temp/asphere +compute_temp_body.html compute temp/body +compute_temp_chunk.html compute temp/chunk +compute_temp_com.html compute temp/com +compute_temp_cs.html compute temp/cs +compute_temp_deform_eff.html compute temp/deform/eff +compute_temp_deform.html compute temp/deform +compute_temp_deform.html compute temp/deform/kk +compute_temp_drude.html compute temp/drude +compute_temp_eff.html compute temp/eff +compute_temp_partial.html compute temp/partial +compute_temp_profile.html compute temp/profile +compute_temp_ramp.html compute temp/ramp +compute_temp_region_eff.html compute temp/region/eff +compute_temp_region.html compute temp/region +compute_temp_rotate.html compute temp/rotate +compute_temp.html compute temp +compute_temp.html compute temp/kk +compute_temp_sphere.html compute temp/sphere +compute_temp_uef.html compute temp/uef +compute_ti.html compute ti +compute_torque_chunk.html compute torque/chunk +compute_vacf.html compute vacf +compute_vcm_chunk.html compute vcm/chunk +compute_viscosity_cos.html compute viscosity/cos +compute_voronoi_atom.html compute voronoi/atom +compute_xrd.html compute xrd +create_atoms.html create_atoms +create_bonds.html create_bonds +create_box.html create_box +delete_atoms.html delete_atoms +delete_bonds.html delete_bonds +dielectric.html dielectric +dihedral_charmm.html dihedral_style charmm +dihedral_charmm.html dihedral_style charmmfsw +dihedral_charmm.html dihedral_style charmm/intel +dihedral_charmm.html dihedral_style charmm/kk +dihedral_charmm.html dihedral_style charmm/omp +dihedral_class2.html dihedral_style class2 +dihedral_class2.html dihedral_style class2/kk +dihedral_class2.html dihedral_style class2/omp +dihedral_coeff.html dihedral_coeff +dihedral_cosine_shift_exp.html dihedral_style cosine/shift/exp +dihedral_cosine_shift_exp.html dihedral_style cosine/shift/exp/omp +dihedral_fourier.html dihedral_style fourier +dihedral_fourier.html dihedral_style fourier/intel +dihedral_fourier.html dihedral_style fourier/omp +dihedral_harmonic.html dihedral_style harmonic +dihedral_harmonic.html dihedral_style harmonic/intel +dihedral_harmonic.html dihedral_style harmonic/kk +dihedral_harmonic.html dihedral_style harmonic/omp +dihedral_helix.html dihedral_style helix +dihedral_helix.html dihedral_style helix/omp +dihedral_hybrid.html dihedral_style hybrid +dihedral_lepton.html dihedral_style lepton +dihedral_lepton.html dihedral_style lepton/omp +dihedral_multi_harmonic.html dihedral_style multi/harmonic +dihedral_multi_harmonic.html dihedral_style multi/harmonic/omp +dihedral_nharmonic.html dihedral_style nharmonic +dihedral_nharmonic.html dihedral_style nharmonic/omp +dihedral_none.html dihedral_style none +dihedral_opls.html dihedral_style opls +dihedral_opls.html dihedral_style opls/intel +dihedral_opls.html dihedral_style opls/kk +dihedral_opls.html dihedral_style opls/omp +dihedral_quadratic.html dihedral_style quadratic +dihedral_quadratic.html dihedral_style quadratic/omp +dihedral_spherical.html dihedral_style spherical +dihedral_style.html dihedral_style +dihedral_table.html dihedral_style table +dihedral_table.html dihedral_style table/cut +dihedral_table.html dihedral_style table/omp +dihedral_write.html dihedral_write +dihedral_zero.html dihedral_style zero +dimension.html dimension +displace_atoms.html displace_atoms +dump_adios.html dump atom/adios +dump_adios.html dump custom/adios +dump_cfg_uef.html dump cfg/uef +dump_h5md.html dump h5md +dump_image.html dump image +dump_image.html dump movie +dump_modify.html dump_modify +dump_molfile.html dump molfile +dump_netcdf.html dump netcdf +dump_netcdf.html dump netcdf/mpiio +dump.html dump +dump.html dump atom +dump.html dump atom/gz +dump.html dump atom/mpiio +dump.html dump atom/zstd +dump.html dump cfg +dump.html dump cfg/gz +dump.html dump cfg/mpiio +dump.html dump cfg/zstd +dump.html dump custom +dump.html dump custom/gz +dump.html dump custom/mpiio +dump.html dump custom/zstd +dump.html dump dcd +dump.html dump grid +dump.html dump grid/vtk +dump.html dump local +dump.html dump local/gz +dump.html dump local/zstd +dump.html dump xtc +dump.html dump xyz +dump.html dump xyz/gz +dump.html dump xyz/mpiio +dump.html dump xyz/zstd +dump.html dump yaml +dump_vtk.html dump vtk +dynamical_matrix.html dynamical_matrix +dynamical_matrix.html dynamical_matrix/kk +echo.html echo +fitpod_command.html fitpod +fix_accelerate_cos.html fix accelerate/cos +fix_acks2_reaxff.html fix acks2/reaxff +fix_acks2_reaxff.html fix acks2/reaxff/kk +fix_adapt_fep.html fix adapt/fep +fix_adapt.html fix adapt +fix_addforce.html fix addforce +fix_addtorque.html fix addtorque +fix_alchemy.html fix alchemy +fix_amoeba_bitorsion.html fix amoeba/bitorsion +fix_amoeba_pitorsion.html fix amoeba/pitorsion +fix_append_atoms.html fix append/atoms +fix_atc.html fix atc +fix_atom_swap.html fix atom/swap +fix_ave_atom.html fix ave/atom +fix_ave_chunk.html fix ave/chunk +fix_ave_correlate_long.html fix ave/correlate/long +fix_ave_correlate.html fix ave/correlate +fix_aveforce.html fix aveforce +fix_ave_grid.html fix ave/grid +fix_ave_histo.html fix ave/histo +fix_ave_histo.html fix ave/histo/weight +fix_ave_time.html fix ave/time +fix_balance.html fix balance +fix_bocs.html fix bocs +fix_bond_break.html fix bond/break +fix_bond_create.html fix bond/create +fix_bond_create.html fix bond/create/angle +fix_bond_react.html fix bond/react +fix_bond_swap.html fix bond/swap +fix_box_relax.html fix box/relax +fix_brownian.html fix brownian +fix_brownian.html fix brownian/asphere +fix_brownian.html fix brownian/sphere +fix_charge_regulation.html fix charge/regulation +fix_cmap.html fix cmap +fix_colvars.html fix colvars +fix_controller.html fix controller +fix_damping_cundall.html fix damping/cundall +fix_deform.html fix deform +fix_deform.html fix deform/kk +fix_deposit.html fix deposit +fix_dpd_energy.html fix dpd/energy +fix_dpd_energy.html fix dpd/energy/kk +fix_dpd_source.html fix edpd/source +fix_dpd_source.html fix tdpd/source +fix_drag.html fix drag +fix_drude.html fix drude +fix_drude_transform.html fix drude/transform/direct +fix_drude_transform.html fix drude/transform/inverse +fix_dt_reset.html fix dt/reset +fix_dt_reset.html fix dt/reset/kk +fix_efield.html fix efield +fix_efield.html fix efield/tip4p +fix_ehex.html fix ehex +fix_electrode.html fix electrode/conp +fix_electrode.html fix electrode/conp/intel +fix_electrode.html fix electrode/conq +fix_electrode.html fix electrode/conq/intel +fix_electrode.html fix electrode/thermo +fix_electrode.html fix electrode/thermo/intel +fix_electron_stopping.html fix electron/stopping +fix_electron_stopping.html fix electron/stopping/fit +fix_enforce2d.html fix enforce2d +fix_enforce2d.html fix enforce2d/kk +fix_eos_cv.html fix eos/cv +fix_eos_table.html fix eos/table +fix_eos_table_rx.html fix eos/table/rx +fix_eos_table_rx.html fix eos/table/rx/kk +fix_evaporate.html fix evaporate +fix_external.html fix external +fix_ffl.html fix ffl +fix_filter_corotate.html fix filter/corotate +fix_flow_gauss.html fix flow/gauss +fix_freeze.html fix freeze +fix_freeze.html fix freeze/kk +fix_gcmc.html fix gcmc +fix_gld.html fix gld +fix_gle.html fix gle +fix_gravity.html fix gravity +fix_gravity.html fix gravity/kk +fix_gravity.html fix gravity/omp +fix_grem.html fix grem +fix_halt.html fix halt +fix_heat_flow.html fix heat/flow +fix_heat.html fix heat +fix_hyper_global.html fix hyper/global +fix_hyper_local.html fix hyper/local +fix_imd.html fix imd +fix_indent.html fix indent +fix_ipi.html fix ipi +fix_langevin_drude.html fix langevin/drude +fix_langevin_eff.html fix langevin/eff +fix_langevin.html fix langevin +fix_langevin.html fix langevin/kk +fix_langevin_spin.html fix langevin/spin +fix_lb_fluid.html fix lb/fluid +fix_lb_momentum.html fix lb/momentum +fix_lb_viscous.html fix lb/viscous +fix_lineforce.html fix lineforce +fix_manifoldforce.html fix manifoldforce +fix_mdi_qmmm.html fix mdi/qmmm +fix_mdi_qm.html fix mdi/qm +fix_meso_move.html fix meso/move +fix_modify.html fix_modify +fix_mol_swap.html fix mol/swap +fix_momentum.html fix momentum +fix_momentum.html fix momentum/chunk +fix_momentum.html fix momentum/kk +fix_move.html fix move +fix_msst.html fix msst +fix_mvv_dpd.html fix mvv/dpd +fix_mvv_dpd.html fix mvv/edpd +fix_mvv_dpd.html fix mvv/tdpd +fix_neb.html fix neb +fix_neb_spin.html fix neb/spin +fix_nh_eff.html fix nph/eff +fix_nh_eff.html fix npt/eff +fix_nh_eff.html fix nvt/eff +fix_nh.html fix nph +fix_nh.html fix nph/kk +fix_nh.html fix nph/omp +fix_nh.html fix npt +fix_nh.html fix npt/gpu +fix_nh.html fix npt/intel +fix_nh.html fix npt/kk +fix_nh.html fix npt/omp +fix_nh.html fix nvt +fix_nh.html fix nvt/gpu +fix_nh.html fix nvt/intel +fix_nh.html fix nvt/kk +fix_nh.html fix nvt/omp +fix_nh_uef.html fix npt/uef +fix_nh_uef.html fix nvt/uef +fix_nph_asphere.html fix nph/asphere +fix_nph_asphere.html fix nph/asphere/omp +fix_nph_body.html fix nph/body +fix_nph_sphere.html fix nph/sphere +fix_nph_sphere.html fix nph/sphere/omp +fix_nphug.html fix nphug +fix_nphug.html fix nphug/omp +fix_npt_asphere.html fix npt/asphere +fix_npt_asphere.html fix npt/asphere/omp +fix_npt_body.html fix npt/body +fix_npt_cauchy.html fix npt/cauchy +fix_npt_sphere.html fix npt/sphere +fix_npt_sphere.html fix npt/sphere/omp +fix_numdiff.html fix numdiff +fix_numdiff_virial.html fix numdiff/virial +fix_nve_asphere_noforce.html fix nve/asphere/noforce +fix_nve_asphere.html fix nve/asphere +fix_nve_asphere.html fix nve/asphere/gpu +fix_nve_asphere.html fix nve/asphere/intel +fix_nve_awpmd.html fix nve/awpmd +fix_nve_body.html fix nve/body +fix_nve_bpm_sphere.html fix nve/bpm/sphere +fix_nve_dotc_langevin.html fix nve/dotc/langevin +fix_nve_dot.html fix nve/dot +fix_nve_eff.html fix nve/eff +fix_nve_limit.html fix nve/limit +fix_nve_line.html fix nve/line +fix_nve_manifold_rattle.html fix nve/manifold/rattle +fix_nve_noforce.html fix nve/noforce +fix_nve.html fix nve +fix_nve.html fix nve/gpu +fix_nve.html fix nve/intel +fix_nve.html fix nve/kk +fix_nve.html fix nve/omp +fix_nve_sphere.html fix nve/sphere +fix_nve_sphere.html fix nve/sphere/kk +fix_nve_sphere.html fix nve/sphere/omp +fix_nve_spin.html fix nve/spin +fix_nve_tri.html fix nve/tri +fix_nvk.html fix nvk +fix_nvt_asphere.html fix nvt/asphere +fix_nvt_asphere.html fix nvt/asphere/omp +fix_nvt_body.html fix nvt/body +fix_nvt_manifold_rattle.html fix nvt/manifold/rattle +fix_nvt_sllod_eff.html fix nvt/sllod/eff +fix_nvt_sllod.html fix nvt/sllod +fix_nvt_sllod.html fix nvt/sllod/intel +fix_nvt_sllod.html fix nvt/sllod/kk +fix_nvt_sllod.html fix nvt/sllod/omp +fix_nvt_sphere.html fix nvt/sphere +fix_nvt_sphere.html fix nvt/sphere/omp +fix_oneway.html fix oneway +fix_orient_eco.html fix orient/eco +fix_orient.html fix orient/bcc +fix_orient.html fix orient/fcc +fix_pafi.html fix pafi +fix_pair.html fix pair +fix_phonon.html fix phonon +fix_pimd.html fix pimd/langevin +fix_pimd.html fix pimd/nvt +fix_planeforce.html fix planeforce +fix_plumed.html fix plumed +fix_poems.html fix poems +fix_polarize.html fix polarize/bem/gmres +fix_polarize.html fix polarize/bem/icc +fix_polarize.html fix polarize/functional +fix_pour.html fix pour +fix_precession_spin.html fix precession/spin +fix_press_berendsen.html fix press/berendsen +fix_print.html fix print +fix_propel_self.html fix propel/self +fix_property_atom.html fix property/atom +fix_property_atom.html fix property/atom/kk +fix_python_invoke.html fix python/invoke +fix_python_move.html fix python/move +fix_qbmsst.html fix qbmsst +fix_qeq_comb.html fix qeq/comb +fix_qeq_comb.html fix qeq/comb/omp +fix_qeq_reaxff.html fix qeq/reaxff +fix_qeq_reaxff.html fix qeq/reaxff/kk +fix_qeq_reaxff.html fix qeq/reaxff/omp +fix_qeq.html fix qeq/dynamic +fix_qeq.html fix qeq/fire +fix_qeq.html fix qeq/point +fix_qeq.html fix qeq/shielded +fix_qeq.html fix qeq/slater +fix_qmmm.html fix qmmm +fix_qtb.html fix qtb +fix_reaxff_bonds.html fix reaxff/bonds +fix_reaxff_bonds.html fix reaxff/bonds/kk +fix_reaxff_species.html fix reaxff/species +fix_reaxff_species.html fix reaxff/species/kk +fix_recenter.html fix recenter +fix_restrain.html fix restrain +fix_rhok.html fix rhok +fix_rigid_meso.html fix rigid/meso +fix_rigid.html fix rigid +fix_rigid.html fix rigid/nph +fix_rigid.html fix rigid/nph/omp +fix_rigid.html fix rigid/nph/small +fix_rigid.html fix rigid/npt +fix_rigid.html fix rigid/npt/omp +fix_rigid.html fix rigid/npt/small +fix_rigid.html fix rigid/nve +fix_rigid.html fix rigid/nve/omp +fix_rigid.html fix rigid/nve/small +fix_rigid.html fix rigid/nvt +fix_rigid.html fix rigid/nvt/omp +fix_rigid.html fix rigid/nvt/small +fix_rigid.html fix rigid/omp +fix_rigid.html fix rigid/small +fix_rigid.html fix rigid/small/omp +fix.html fix +fix_rx.html fix rx +fix_rx.html fix rx/kk +fix_saed_vtk.html fix saed/vtk +fix_setforce.html fix setforce +fix_setforce.html fix setforce/kk +fix_setforce.html fix setforce/spin +fix_sgcmc.html fix sgcmc +fix_shake.html fix rattle +fix_shake.html fix shake +fix_shake.html fix shake/kk +fix_shardlow.html fix shardlow +fix_shardlow.html fix shardlow/kk +fix_smd_adjust_dt.html fix smd/adjust_dt +fix_smd_integrate_tlsph.html fix smd/integrate_tlsph +fix_smd_integrate_ulsph.html fix smd/integrate_ulsph +fix_smd_move_triangulated_surface.html fix smd/move_tri_surf +fix_smd.html fix smd +fix_smd_setvel.html fix smd/setvel +fix_smd_wall_surface.html fix smd/wall_surface +fix_sph.html fix sph +fix_sph_stationary.html fix sph/stationary +fix_spring_chunk.html fix spring/chunk +fix_spring_rg.html fix spring/rg +fix_spring.html fix spring +fix_spring_self.html fix spring/self +fix_srd.html fix srd +fix_store_force.html fix store/force +fix_store_state.html fix store/state +fix_temp_berendsen.html fix temp/berendsen +fix_temp_csvr.html fix temp/csld +fix_temp_csvr.html fix temp/csvr +fix_temp_rescale_eff.html fix temp/rescale/eff +fix_temp_rescale.html fix temp/rescale +fix_tfmc.html fix tfmc +fix_tgnh_drude.html fix tgnpt/drude +fix_tgnh_drude.html fix tgnvt/drude +fix_thermal_conductivity.html fix thermal/conductivity +fix_ti_spring.html fix ti/spring +fix_tmd.html fix tmd +fix_ttm.html fix ttm +fix_ttm.html fix ttm/grid +fix_ttm.html fix ttm/mod +fix_tune_kspace.html fix tune/kspace +fix_vector.html fix vector +fix_viscosity.html fix viscosity +fix_viscous.html fix viscous +fix_viscous.html fix viscous/kk +fix_viscous_sphere.html fix viscous/sphere +fix_wall_body_polygon.html fix wall/body/polygon +fix_wall_body_polyhedron.html fix wall/body/polyhedron +fix_wall_ees.html fix wall/ees +fix_wall_ees.html fix wall/region/ees +fix_wall_gran_region.html fix wall/gran/region +fix_wall_gran.html fix wall/gran +fix_wall_gran.html fix wall/gran/kk +fix_wall_piston.html fix wall/piston +fix_wall_reflect.html fix wall/reflect +fix_wall_reflect.html fix wall/reflect/kk +fix_wall_reflect_stochastic.html fix wall/reflect/stochastic +fix_wall_region.html fix wall/region +fix_wall.html fix wall/colloid +fix_wall.html fix wall/harmonic +fix_wall.html fix wall/lepton +fix_wall.html fix wall/lj1043 +fix_wall.html fix wall/lj126 +fix_wall.html fix wall/lj93 +fix_wall.html fix wall/lj93/kk +fix_wall.html fix wall/morse +fix_wall.html fix wall/table +fix_wall_srd.html fix wall/srd +fix_widom.html fix widom +group2ndx.html group2ndx +group2ndx.html ndx2group +group.html group +hyper.html hyper +if.html if +improper_amoeba.html improper_style amoeba +improper_class2.html improper_style class2 +improper_class2.html improper_style class2/kk +improper_class2.html improper_style class2/omp +improper_coeff.html improper_coeff +improper_cossq.html improper_style cossq +improper_cossq.html improper_style cossq/omp +improper_cvff.html improper_style cvff +improper_cvff.html improper_style cvff/intel +improper_cvff.html improper_style cvff/omp +improper_distance.html improper_style distance +improper_distharm.html improper_style distharm +improper_fourier.html improper_style fourier +improper_fourier.html improper_style fourier/omp +improper_harmonic.html improper_style harmonic +improper_harmonic.html improper_style harmonic/intel +improper_harmonic.html improper_style harmonic/kk +improper_harmonic.html improper_style harmonic/omp +improper_hybrid.html improper_style hybrid +improper_inversion_harmonic.html improper_style inversion/harmonic +improper_none.html improper_style none +improper_ring.html improper_style ring +improper_ring.html improper_style ring/omp +improper_sqdistharm.html improper_style sqdistharm +improper_style.html improper_style +improper_umbrella.html improper_style umbrella +improper_umbrella.html improper_style umbrella/omp +improper_zero.html improper_style zero +include.html include +info.html info +jump.html jump +kim_commands.html kim_commands +kspace_modify.html kspace_modify +kspace_style.html kspace_style ewald +kspace_style.html kspace_style ewald/dipole +kspace_style.html kspace_style ewald/dipole/spin +kspace_style.html kspace_style ewald/disp +kspace_style.html kspace_style ewald/disp/dipole +kspace_style.html kspace_style ewald/electrode +kspace_style.html kspace_style ewald/omp +kspace_style.html kspace_style msm +kspace_style.html kspace_style msm/cg +kspace_style.html kspace_style msm/cg/omp +kspace_style.html kspace_style msm/dielectric +kspace_style.html kspace_style msm/omp +kspace_style.html kspace_style pppm +kspace_style.html kspace_style pppm/cg +kspace_style.html kspace_style pppm/cg/omp +kspace_style.html kspace_style pppm/dielectric +kspace_style.html kspace_style pppm/dipole +kspace_style.html kspace_style pppm/dipole/spin +kspace_style.html kspace_style pppm/disp +kspace_style.html kspace_style pppm/disp/dielectric +kspace_style.html kspace_style pppm/disp/intel +kspace_style.html kspace_style pppm/disp/omp +kspace_style.html kspace_style pppm/disp/tip4p +kspace_style.html kspace_style pppm/disp/tip4p/omp +kspace_style.html kspace_style pppm/electrode +kspace_style.html kspace_style pppm/electrode/intel +kspace_style.html kspace_style pppm/gpu +kspace_style.html kspace_style pppm/intel +kspace_style.html kspace_style pppm/kk +kspace_style.html kspace_style pppm/omp +kspace_style.html kspace_style pppm/stagger +kspace_style.html kspace_style pppm/tip4p +kspace_style.html kspace_style pppm/tip4p/omp +kspace_style.html kspace_style scafacos +labelmap.html labelmap +label.html label +lattice.html lattice +log.html log +mass.html mass +mdi.html mdi +minimize.html minimize +minimize.html minimize/kk +min_modify.html min_modify +min_spin.html min_style spin +min_style.html min_style +molecule.html molecule +neb.html neb +neb_spin.html neb/spin +neighbor.html neighbor +neigh_modify.html neigh_modify +newton.html newton +next.html next +package.html package +pair_adp.html pair_style adp +pair_adp.html pair_style adp/kk +pair_adp.html pair_style adp/omp +pair_agni.html pair_style agni +pair_agni.html pair_style agni/omp +pair_aip_water_2dm.html pair_style aip/water/2dm +pair_aip_water_2dm.html pair_style aip/water/2dm/opt +pair_airebo.html pair_style airebo +pair_airebo.html pair_style airebo/intel +pair_airebo.html pair_style airebo/morse +pair_airebo.html pair_style airebo/morse/intel +pair_airebo.html pair_style airebo/morse/omp +pair_airebo.html pair_style airebo/omp +pair_airebo.html pair_style rebo +pair_airebo.html pair_style rebo/intel +pair_airebo.html pair_style rebo/omp +pair_amoeba.html pair_style amoeba +pair_amoeba.html pair_style amoeba/gpu +pair_amoeba.html pair_style hippo +pair_amoeba.html pair_style hippo/gpu +pair_atm.html pair_style atm +pair_awpmd.html pair_style awpmd/cut +pair_beck.html pair_style beck +pair_beck.html pair_style beck/gpu +pair_beck.html pair_style beck/omp +pair_body_nparticle.html pair_style body/nparticle +pair_body_rounded_polygon.html pair_style body/rounded/polygon +pair_body_rounded_polyhedron.html pair_style body/rounded/polyhedron +pair_bop.html pair_style bop +pair_born_gauss.html pair_style born/gauss +pair_born.html pair_style born +pair_born.html pair_style born/coul/dsf +pair_born.html pair_style born/coul/long +pair_born.html pair_style born/coul/long/gpu +pair_born.html pair_style born/coul/long/omp +pair_born.html pair_style born/coul/msm +pair_born.html pair_style born/coul/msm/omp +pair_born.html pair_style born/coul/wolf +pair_born.html pair_style born/coul/wolf/gpu +pair_born.html pair_style born/coul/wolf/omp +pair_born.html pair_style born/gpu +pair_born.html pair_style born/omp +pair_bpm_spring.html pair_style bpm/spring +pair_brownian.html pair_style brownian +pair_brownian.html pair_style brownian/omp +pair_brownian.html pair_style brownian/poly +pair_brownian.html pair_style brownian/poly/omp +pair_buck6d_coul_gauss.html pair_style buck6d/coul/gauss/dsf +pair_buck6d_coul_gauss.html pair_style buck6d/coul/gauss/long +pair_buck_long.html pair_style buck/long/coul/long +pair_buck_long.html pair_style buck/long/coul/long/omp +pair_buck.html pair_style buck +pair_buck.html pair_style buck/coul/cut +pair_buck.html pair_style buck/coul/cut/gpu +pair_buck.html pair_style buck/coul/cut/intel +pair_buck.html pair_style buck/coul/cut/kk +pair_buck.html pair_style buck/coul/cut/omp +pair_buck.html pair_style buck/coul/long +pair_buck.html pair_style buck/coul/long/gpu +pair_buck.html pair_style buck/coul/long/intel +pair_buck.html pair_style buck/coul/long/kk +pair_buck.html pair_style buck/coul/long/omp +pair_buck.html pair_style buck/coul/msm +pair_buck.html pair_style buck/coul/msm/omp +pair_buck.html pair_style buck/gpu +pair_buck.html pair_style buck/intel +pair_buck.html pair_style buck/kk +pair_buck.html pair_style buck/omp +pair_charmm.html pair_style lj/charmm/coul/charmm +pair_charmm.html pair_style lj/charmm/coul/charmm/gpu +pair_charmm.html pair_style lj/charmm/coul/charmm/implicit +pair_charmm.html pair_style lj/charmm/coul/charmm/implicit/kk +pair_charmm.html pair_style lj/charmm/coul/charmm/implicit/omp +pair_charmm.html pair_style lj/charmm/coul/charmm/intel +pair_charmm.html pair_style lj/charmm/coul/charmm/kk +pair_charmm.html pair_style lj/charmm/coul/charmm/omp +pair_charmm.html pair_style lj/charmm/coul/long +pair_charmm.html pair_style lj/charmm/coul/long/gpu +pair_charmm.html pair_style lj/charmm/coul/long/intel +pair_charmm.html pair_style lj/charmm/coul/long/kk +pair_charmm.html pair_style lj/charmm/coul/long/omp +pair_charmm.html pair_style lj/charmm/coul/long/opt +pair_charmm.html pair_style lj/charmm/coul/msm +pair_charmm.html pair_style lj/charmm/coul/msm/omp +pair_charmm.html pair_style lj/charmmfsw/coul/charmmfsh +pair_charmm.html pair_style lj/charmmfsw/coul/long +pair_class2.html pair_style lj/class2 +pair_class2.html pair_style lj/class2/coul/cut +pair_class2.html pair_style lj/class2/coul/cut/kk +pair_class2.html pair_style lj/class2/coul/cut/omp +pair_class2.html pair_style lj/class2/coul/long +pair_class2.html pair_style lj/class2/coul/long/gpu +pair_class2.html pair_style lj/class2/coul/long/kk +pair_class2.html pair_style lj/class2/coul/long/omp +pair_class2.html pair_style lj/class2/gpu +pair_class2.html pair_style lj/class2/kk +pair_class2.html pair_style lj/class2/omp +pair_coeff.html pair_coeff +pair_colloid.html pair_style colloid +pair_colloid.html pair_style colloid/gpu +pair_colloid.html pair_style colloid/omp +pair_comb.html pair_style comb +pair_comb.html pair_style comb3 +pair_comb.html pair_style comb/omp +pair_cosine_squared.html pair_style cosine/squared +pair_coul_diel.html pair_style coul/diel +pair_coul_diel.html pair_style coul/diel/omp +pair_coul.html pair_style coul/cut +pair_coul.html pair_style coul/cut/global +pair_coul.html pair_style coul/cut/global/omp +pair_coul.html pair_style coul/cut/gpu +pair_coul.html pair_style coul/cut/kk +pair_coul.html pair_style coul/cut/omp +pair_coul.html pair_style coul/debye +pair_coul.html pair_style coul/debye/gpu +pair_coul.html pair_style coul/debye/kk +pair_coul.html pair_style coul/debye/omp +pair_coul.html pair_style coul/dsf +pair_coul.html pair_style coul/dsf/gpu +pair_coul.html pair_style coul/dsf/kk +pair_coul.html pair_style coul/dsf/omp +pair_coul.html pair_style coul/exclude +pair_coul.html pair_style coul/long +pair_coul.html pair_style coul/long/gpu +pair_coul.html pair_style coul/long/kk +pair_coul.html pair_style coul/long/omp +pair_coul.html pair_style coul/msm +pair_coul.html pair_style coul/msm/omp +pair_coul.html pair_style coul/streitz +pair_coul.html pair_style coul/wolf +pair_coul.html pair_style coul/wolf/kk +pair_coul.html pair_style coul/wolf/omp +pair_coul.html pair_style tip4p/cut +pair_coul.html pair_style tip4p/cut/omp +pair_coul.html pair_style tip4p/long +pair_coul.html pair_style tip4p/long/omp +pair_coul_shield.html pair_style coul/shield +pair_coul_slater.html pair_style coul/slater +pair_coul_slater.html pair_style coul/slater/cut +pair_coul_slater.html pair_style coul/slater/long +pair_coul_tt.html pair_style coul/tt +pair_cs.html pair_style born/coul/dsf/cs +pair_cs.html pair_style born/coul/long/cs +pair_cs.html pair_style born/coul/long/cs/gpu +pair_cs.html pair_style born/coul/wolf/cs +pair_cs.html pair_style born/coul/wolf/cs/gpu +pair_cs.html pair_style buck/coul/long/cs +pair_cs.html pair_style coul/long/cs +pair_cs.html pair_style coul/long/cs/gpu +pair_cs.html pair_style coul/wolf/cs +pair_cs.html pair_style lj/class2/coul/long/cs +pair_cs.html pair_style lj/cut/coul/long/cs +pair_dielectric.html pair_style coul/cut/dielectric +pair_dielectric.html pair_style coul/long/dielectric +pair_dielectric.html pair_style lj/cut/coul/cut/dielectric +pair_dielectric.html pair_style lj/cut/coul/cut/dielectric/omp +pair_dielectric.html pair_style lj/cut/coul/debye/dielectric +pair_dielectric.html pair_style lj/cut/coul/debye/dielectric/omp +pair_dielectric.html pair_style lj/cut/coul/long/dielectric +pair_dielectric.html pair_style lj/cut/coul/long/dielectric/omp +pair_dielectric.html pair_style lj/cut/coul/msm/dielectric +pair_dielectric.html pair_style lj/long/coul/long/dielectric +pair_dipole.html pair_style lj/cut/dipole/cut +pair_dipole.html pair_style lj/cut/dipole/cut/gpu +pair_dipole.html pair_style lj/cut/dipole/cut/kk +pair_dipole.html pair_style lj/cut/dipole/cut/omp +pair_dipole.html pair_style lj/cut/dipole/long +pair_dipole.html pair_style lj/cut/dipole/long/gpu +pair_dipole.html pair_style lj/long/dipole/long +pair_dipole.html pair_style lj/sf/dipole/sf +pair_dipole.html pair_style lj/sf/dipole/sf/gpu +pair_dipole.html pair_style lj/sf/dipole/sf/omp +pair_dpd_ext.html pair_style dpd/ext +pair_dpd_ext.html pair_style dpd/ext/kk +pair_dpd_ext.html pair_style dpd/ext/omp +pair_dpd_ext.html pair_style dpd/ext/tstat +pair_dpd_ext.html pair_style dpd/ext/tstat/kk +pair_dpd_ext.html pair_style dpd/ext/tstat/omp +pair_dpd_fdt.html pair_style dpd/fdt +pair_dpd_fdt.html pair_style dpd/fdt/energy +pair_dpd_fdt.html pair_style dpd/fdt/energy/kk +pair_dpd.html pair_style dpd +pair_dpd.html pair_style dpd/gpu +pair_dpd.html pair_style dpd/intel +pair_dpd.html pair_style dpd/kk +pair_dpd.html pair_style dpd/omp +pair_dpd.html pair_style dpd/tstat +pair_dpd.html pair_style dpd/tstat/gpu +pair_dpd.html pair_style dpd/tstat/kk +pair_dpd.html pair_style dpd/tstat/omp +pair_drip.html pair_style drip +pair_dsmc.html pair_style dsmc +pair_e3b.html pair_style e3b +pair_eam.html pair_style eam +pair_eam.html pair_style eam/alloy +pair_eam.html pair_style eam/alloy/gpu +pair_eam.html pair_style eam/alloy/intel +pair_eam.html pair_style eam/alloy/kk +pair_eam.html pair_style eam/alloy/omp +pair_eam.html pair_style eam/alloy/opt +pair_eam.html pair_style eam/cd +pair_eam.html pair_style eam/cd/old +pair_eam.html pair_style eam/fs +pair_eam.html pair_style eam/fs/gpu +pair_eam.html pair_style eam/fs/intel +pair_eam.html pair_style eam/fs/kk +pair_eam.html pair_style eam/fs/omp +pair_eam.html pair_style eam/fs/opt +pair_eam.html pair_style eam/gpu +pair_eam.html pair_style eam/he +pair_eam.html pair_style eam/intel +pair_eam.html pair_style eam/kk +pair_eam.html pair_style eam/omp +pair_eam.html pair_style eam/opt +pair_edip.html pair_style edip +pair_edip.html pair_style edip/multi +pair_edip.html pair_style edip/omp +pair_eff.html pair_style eff/cut +pair_eim.html pair_style eim +pair_eim.html pair_style eim/omp +pair_exp6_rx.html pair_style exp6/rx +pair_exp6_rx.html pair_style exp6/rx/kk +pair_extep.html pair_style extep +pair_fep_soft.html pair_style coul/cut/soft +pair_fep_soft.html pair_style coul/cut/soft/omp +pair_fep_soft.html pair_style coul/long/soft +pair_fep_soft.html pair_style coul/long/soft/omp +pair_fep_soft.html pair_style lj/charmm/coul/long/soft +pair_fep_soft.html pair_style lj/charmm/coul/long/soft/omp +pair_fep_soft.html pair_style lj/class2/coul/cut/soft +pair_fep_soft.html pair_style lj/class2/coul/long/soft +pair_fep_soft.html pair_style lj/class2/soft +pair_fep_soft.html pair_style lj/cut/coul/cut/soft +pair_fep_soft.html pair_style lj/cut/coul/cut/soft/omp +pair_fep_soft.html pair_style lj/cut/coul/long/soft +pair_fep_soft.html pair_style lj/cut/coul/long/soft/omp +pair_fep_soft.html pair_style lj/cut/soft +pair_fep_soft.html pair_style lj/cut/soft/omp +pair_fep_soft.html pair_style lj/cut/tip4p/long/soft +pair_fep_soft.html pair_style lj/cut/tip4p/long/soft/omp +pair_fep_soft.html pair_style morse/soft +pair_fep_soft.html pair_style tip4p/long/soft +pair_fep_soft.html pair_style tip4p/long/soft/omp +pair_gauss.html pair_style gauss +pair_gauss.html pair_style gauss/cut +pair_gauss.html pair_style gauss/cut/omp +pair_gauss.html pair_style gauss/gpu +pair_gauss.html pair_style gauss/omp +pair_gayberne.html pair_style gayberne +pair_gayberne.html pair_style gayberne/gpu +pair_gayberne.html pair_style gayberne/intel +pair_gayberne.html pair_style gayberne/omp +pair_gran.html pair_style gran/hertz/history +pair_gran.html pair_style gran/hertz/history/omp +pair_gran.html pair_style gran/hooke +pair_gran.html pair_style gran/hooke/history +pair_gran.html pair_style gran/hooke/history/kk +pair_gran.html pair_style gran/hooke/history/omp +pair_gran.html pair_style gran/hooke/omp +pair_granular.html pair_style granular +pair_gromacs.html pair_style lj/gromacs +pair_gromacs.html pair_style lj/gromacs/coul/gromacs +pair_gromacs.html pair_style lj/gromacs/coul/gromacs/kk +pair_gromacs.html pair_style lj/gromacs/coul/gromacs/omp +pair_gromacs.html pair_style lj/gromacs/gpu +pair_gromacs.html pair_style lj/gromacs/kk +pair_gromacs.html pair_style lj/gromacs/omp +pair_gw.html pair_style gw +pair_gw.html pair_style gw/zbl +pair_harmonic_cut.html pair_style harmonic/cut +pair_harmonic_cut.html pair_style harmonic/cut/omp +pair_hbond_dreiding.html pair_style hbond/dreiding/lj +pair_hbond_dreiding.html pair_style hbond/dreiding/lj/omp +pair_hbond_dreiding.html pair_style hbond/dreiding/morse +pair_hbond_dreiding.html pair_style hbond/dreiding/morse/omp +pair_hdnnp.html pair_style hdnnp +pair_hybrid.html pair_style hybrid +pair_hybrid.html pair_style hybrid/kk +pair_hybrid.html pair_style hybrid/overlay +pair_hybrid.html pair_style hybrid/overlay/kk +pair_hybrid.html pair_style hybrid/scaled +pair_ilp_graphene_hbn.html pair_style ilp/graphene/hbn +pair_ilp_graphene_hbn.html pair_style ilp/graphene/hbn/opt +pair_ilp_tmd.html pair_style ilp/tmd +pair_ilp_tmd.html pair_style ilp/tmd/opt +pair_kim.html pair_style kim +pair_kolmogorov_crespi_full.html pair_style kolmogorov/crespi/full +pair_kolmogorov_crespi_z.html pair_style kolmogorov/crespi/z +pair_lcbop.html pair_style lcbop +pair_lebedeva_z.html pair_style lebedeva/z +pair_lepton.html pair_style lepton +pair_lepton.html pair_style lepton/coul +pair_lepton.html pair_style lepton/coul/omp +pair_lepton.html pair_style lepton/omp +pair_lepton.html pair_style lepton/sphere +pair_lepton.html pair_style lepton/sphere/omp +pair_line_lj.html pair_style line/lj +pair_list.html pair_style list +pair_lj96.html pair_style lj96/cut +pair_lj96.html pair_style lj96/cut/gpu +pair_lj96.html pair_style lj96/cut/omp +pair_lj_cubic.html pair_style lj/cubic +pair_lj_cubic.html pair_style lj/cubic/gpu +pair_lj_cubic.html pair_style lj/cubic/omp +pair_lj_cut_coul.html pair_style lj/cut/coul/cut +pair_lj_cut_coul.html pair_style lj/cut/coul/cut/gpu +pair_lj_cut_coul.html pair_style lj/cut/coul/cut/kk +pair_lj_cut_coul.html pair_style lj/cut/coul/cut/omp +pair_lj_cut_coul.html pair_style lj/cut/coul/debye +pair_lj_cut_coul.html pair_style lj/cut/coul/debye/gpu +pair_lj_cut_coul.html pair_style lj/cut/coul/debye/kk +pair_lj_cut_coul.html pair_style lj/cut/coul/debye/omp +pair_lj_cut_coul.html pair_style lj/cut/coul/dsf +pair_lj_cut_coul.html pair_style lj/cut/coul/dsf/gpu +pair_lj_cut_coul.html pair_style lj/cut/coul/dsf/kk +pair_lj_cut_coul.html pair_style lj/cut/coul/dsf/omp +pair_lj_cut_coul.html pair_style lj/cut/coul/long +pair_lj_cut_coul.html pair_style lj/cut/coul/long/gpu +pair_lj_cut_coul.html pair_style lj/cut/coul/long/intel +pair_lj_cut_coul.html pair_style lj/cut/coul/long/kk +pair_lj_cut_coul.html pair_style lj/cut/coul/long/omp +pair_lj_cut_coul.html pair_style lj/cut/coul/long/opt +pair_lj_cut_coul.html pair_style lj/cut/coul/msm +pair_lj_cut_coul.html pair_style lj/cut/coul/msm/gpu +pair_lj_cut_coul.html pair_style lj/cut/coul/msm/omp +pair_lj_cut_coul.html pair_style lj/cut/coul/wolf +pair_lj_cut_coul.html pair_style lj/cut/coul/wolf/omp +pair_lj_cut_sphere.html pair_style lj/cut/sphere +pair_lj_cut_sphere.html pair_style lj/cut/sphere/omp +pair_lj_cut_tip4p.html pair_style lj/cut/tip4p/cut +pair_lj_cut_tip4p.html pair_style lj/cut/tip4p/cut/omp +pair_lj_cut_tip4p.html pair_style lj/cut/tip4p/long +pair_lj_cut_tip4p.html pair_style lj/cut/tip4p/long/gpu +pair_lj_cut_tip4p.html pair_style lj/cut/tip4p/long/omp +pair_lj_cut_tip4p.html pair_style lj/cut/tip4p/long/opt +pair_lj_expand.html pair_style lj/expand +pair_lj_expand.html pair_style lj/expand/coul/long +pair_lj_expand.html pair_style lj/expand/coul/long/gpu +pair_lj_expand.html pair_style lj/expand/coul/long/kk +pair_lj_expand.html pair_style lj/expand/gpu +pair_lj_expand.html pair_style lj/expand/kk +pair_lj_expand.html pair_style lj/expand/omp +pair_lj_expand_sphere.html pair_style lj/expand/sphere +pair_lj_expand_sphere.html pair_style lj/expand/sphere/omp +pair_lj_long.html pair_style lj/long/coul/long +pair_lj_long.html pair_style lj/long/coul/long/intel +pair_lj_long.html pair_style lj/long/coul/long/omp +pair_lj_long.html pair_style lj/long/coul/long/opt +pair_lj_long.html pair_style lj/long/tip4p/long +pair_lj_long.html pair_style lj/long/tip4p/long/omp +pair_lj_relres.html pair_style lj/relres +pair_lj_relres.html pair_style lj/relres/omp +pair_lj.html pair_style lj/cut +pair_lj.html pair_style lj/cut/gpu +pair_lj.html pair_style lj/cut/intel +pair_lj.html pair_style lj/cut/kk +pair_lj.html pair_style lj/cut/omp +pair_lj.html pair_style lj/cut/opt +pair_lj_smooth_linear.html pair_style lj/smooth/linear +pair_lj_smooth_linear.html pair_style lj/smooth/linear/omp +pair_lj_smooth.html pair_style lj/smooth +pair_lj_smooth.html pair_style lj/smooth/gpu +pair_lj_smooth.html pair_style lj/smooth/omp +pair_lj_switch3_coulgauss_long.html pair_style lj/switch3/coulgauss/long +pair_lj_switch3_coulgauss_long.html pair_style mm3/switch3/coulgauss/long +pair_local_density.html pair_style local/density +pair_lubricate.html pair_style lubricate +pair_lubricate.html pair_style lubricate/omp +pair_lubricate.html pair_style lubricate/poly +pair_lubricate.html pair_style lubricate/poly/omp +pair_lubricateU.html pair_style lubricateU +pair_lubricateU.html pair_style lubricateU/poly +pair_mdf.html pair_style buck/mdf +pair_mdf.html pair_style lennard/mdf +pair_mdf.html pair_style lj/mdf +pair_meam.html pair_style meam +pair_meam.html pair_style meam/kk +pair_meam.html pair_style meam/ms +pair_meam.html pair_style meam/ms/kk +pair_meam_spline.html pair_style meam/spline +pair_meam_spline.html pair_style meam/spline/omp +pair_meam_sw_spline.html pair_style meam/sw/spline +pair_mesocnt.html pair_style mesocnt +pair_mesocnt.html pair_style mesocnt/viscous +pair_mesodpd.html pair_style edpd +pair_mesodpd.html pair_style mdpd +pair_mesodpd.html pair_style mdpd/rhosum +pair_mesodpd.html pair_style tdpd +pair_mgpt.html pair_style mgpt +pair_mie.html pair_style mie/cut +pair_mie.html pair_style mie/cut/gpu +pair_mliap.html pair_style mliap +pair_mliap.html pair_style mliap/kk +pair_modify.html pair_modify +pair_momb.html pair_style momb +pair_morse.html pair_style morse +pair_morse.html pair_style morse/gpu +pair_morse.html pair_style morse/kk +pair_morse.html pair_style morse/omp +pair_morse.html pair_style morse/opt +pair_morse.html pair_style morse/smooth/linear +pair_morse.html pair_style morse/smooth/linear/omp +pair_multi_lucy.html pair_style multi/lucy +pair_multi_lucy_rx.html pair_style multi/lucy/rx +pair_multi_lucy_rx.html pair_style multi/lucy/rx/kk +pair_nb3b_harmonic.html pair_style nb3b/harmonic +pair_nm.html pair_style nm/cut +pair_nm.html pair_style nm/cut/coul/cut +pair_nm.html pair_style nm/cut/coul/cut/omp +pair_nm.html pair_style nm/cut/coul/long +pair_nm.html pair_style nm/cut/coul/long/omp +pair_nm.html pair_style nm/cut/omp +pair_nm.html pair_style nm/cut/split +pair_none.html pair_style none +pair_oxdna2.html pair_style oxdna2/coaxstk +pair_oxdna2.html pair_style oxdna2/dh +pair_oxdna2.html pair_style oxdna2/excv +pair_oxdna2.html pair_style oxdna2/hbond +pair_oxdna2.html pair_style oxdna2/stk +pair_oxdna2.html pair_style oxdna2/xstk +pair_oxdna.html pair_style oxdna/coaxstk +pair_oxdna.html pair_style oxdna/excv +pair_oxdna.html pair_style oxdna/hbond +pair_oxdna.html pair_style oxdna/stk +pair_oxdna.html pair_style oxdna/xstk +pair_oxrna2.html pair_style oxrna2/coaxstk +pair_oxrna2.html pair_style oxrna2/dh +pair_oxrna2.html pair_style oxrna2/excv +pair_oxrna2.html pair_style oxrna2/hbond +pair_oxrna2.html pair_style oxrna2/stk +pair_oxrna2.html pair_style oxrna2/xstk +pair_pace.html pair_style pace +pair_pace.html pair_style pace/extrapolation +pair_pace.html pair_style pace/extrapolation/kk +pair_pace.html pair_style pace/kk +pair_peri.html pair_style peri/eps +pair_peri.html pair_style peri/lps +pair_peri.html pair_style peri/lps/omp +pair_peri.html pair_style peri/pmb +pair_peri.html pair_style peri/pmb/omp +pair_peri.html pair_style peri/ves +pair_pod.html pair_style pod +pair_polymorphic.html pair_style polymorphic +pair_python.html pair_style python +pair_quip.html pair_style quip +pair_rann.html pair_style rann +pair_reaxff.html pair_style reaxff +pair_reaxff.html pair_style reaxff/kk +pair_reaxff.html pair_style reaxff/omp +pair_resquared.html pair_style resquared +pair_resquared.html pair_style resquared/gpu +pair_resquared.html pair_style resquared/omp +pair_saip_metal.html pair_style saip/metal +pair_saip_metal.html pair_style saip/metal/opt +pair_sdpd_taitwater_isothermal.html pair_style sdpd/taitwater/isothermal +pair_smatb.html pair_style smatb +pair_smatb.html pair_style smatb/single +pair_smd_hertz.html pair_style smd/hertz +pair_smd_tlsph.html pair_style smd/tlsph +pair_smd_triangulated_surface.html pair_style smd/tri_surface +pair_smd_ulsph.html pair_style smd/ulsph +pair_smtbq.html pair_style smtbq +pair_snap.html pair_style snap +pair_snap.html pair_style snap/kk +pair_soft.html pair_style soft +pair_soft.html pair_style soft/gpu +pair_soft.html pair_style soft/omp +pair_sph_heatconduction.html pair_style sph/heatconduction +pair_sph_idealgas.html pair_style sph/idealgas +pair_sph_lj.html pair_style sph/lj +pair_sph_rhosum.html pair_style sph/rhosum +pair_sph_taitwater_morris.html pair_style sph/taitwater/morris +pair_sph_taitwater.html pair_style sph/taitwater +pair_spica.html pair_style lj/spica +pair_spica.html pair_style lj/spica/coul/long +pair_spica.html pair_style lj/spica/coul/long/gpu +pair_spica.html pair_style lj/spica/coul/long/omp +pair_spica.html pair_style lj/spica/coul/msm +pair_spica.html pair_style lj/spica/coul/msm/omp +pair_spica.html pair_style lj/spica/gpu +pair_spica.html pair_style lj/spica/kk +pair_spica.html pair_style lj/spica/omp +pair_spin_dipole.html pair_style spin/dipole/cut +pair_spin_dipole.html pair_style spin/dipole/long +pair_spin_dmi.html pair_style spin/dmi +pair_spin_exchange.html pair_style spin/exchange +pair_spin_exchange.html pair_style spin/exchange/biquadratic +pair_spin_magelec.html pair_style spin/magelec +pair_spin_neel.html pair_style spin/neel +pair_srp.html pair_style srp +pair_srp.html pair_style srp/react +pair_style.html pair_style +pair_sw_angle_table.html pair_style sw/angle/table +pair_sw.html pair_style sw +pair_sw.html pair_style sw/gpu +pair_sw.html pair_style sw/intel +pair_sw.html pair_style sw/kk +pair_sw.html pair_style sw/mod +pair_sw.html pair_style sw/mod/omp +pair_sw.html pair_style sw/omp +pair_table.html pair_style table +pair_table.html pair_style table/gpu +pair_table.html pair_style table/kk +pair_table.html pair_style table/omp +pair_table_rx.html pair_style table/rx +pair_table_rx.html pair_style table/rx/kk +pair_tersoff_mod.html pair_style tersoff/mod +pair_tersoff_mod.html pair_style tersoff/mod/c +pair_tersoff_mod.html pair_style tersoff/mod/c/omp +pair_tersoff_mod.html pair_style tersoff/mod/gpu +pair_tersoff_mod.html pair_style tersoff/mod/kk +pair_tersoff_mod.html pair_style tersoff/mod/omp +pair_tersoff.html pair_style tersoff +pair_tersoff.html pair_style tersoff/gpu +pair_tersoff.html pair_style tersoff/intel +pair_tersoff.html pair_style tersoff/kk +pair_tersoff.html pair_style tersoff/omp +pair_tersoff.html pair_style tersoff/table +pair_tersoff.html pair_style tersoff/table/omp +pair_tersoff_zbl.html pair_style tersoff/zbl +pair_tersoff_zbl.html pair_style tersoff/zbl/gpu +pair_tersoff_zbl.html pair_style tersoff/zbl/kk +pair_tersoff_zbl.html pair_style tersoff/zbl/omp +pair_thole.html pair_style lj/cut/thole/long +pair_thole.html pair_style lj/cut/thole/long/omp +pair_thole.html pair_style thole +pair_threebody_table.html pair_style threebody/table +pair_tracker.html pair_style tracker +pair_tri_lj.html pair_style tri/lj +pair_ufm.html pair_style ufm +pair_ufm.html pair_style ufm/gpu +pair_ufm.html pair_style ufm/omp +pair_ufm.html pair_style ufm/opt +pair_vashishta.html pair_style vashishta +pair_vashishta.html pair_style vashishta/gpu +pair_vashishta.html pair_style vashishta/kk +pair_vashishta.html pair_style vashishta/omp +pair_vashishta.html pair_style vashishta/table +pair_vashishta.html pair_style vashishta/table/omp +pair_wf_cut.html pair_style wf/cut +pair_write.html pair_write +pair_ylz.html pair_style ylz +pair_yukawa_colloid.html pair_style yukawa/colloid +pair_yukawa_colloid.html pair_style yukawa/colloid/gpu +pair_yukawa_colloid.html pair_style yukawa/colloid/omp +pair_yukawa.html pair_style yukawa +pair_yukawa.html pair_style yukawa/gpu +pair_yukawa.html pair_style yukawa/kk +pair_yukawa.html pair_style yukawa/omp +pair_zbl.html pair_style zbl +pair_zbl.html pair_style zbl/gpu +pair_zbl.html pair_style zbl/kk +pair_zbl.html pair_style zbl/omp +pair_zero.html pair_style zero +partition.html partition +plugin.html plugin +prd.html prd +print.html print +processors.html processors +python.html python +quit.html quit +read_data.html read_data +read_dump.html read_dump +read_restart.html read_restart +region.html region +replicate.html replicate +rerun.html rerun +reset_atoms.html reset_atoms +reset_timestep.html reset_timestep +restart.html restart +run.html run +run_style.html run_style +set.html set +shell.html shell +special_bonds.html special_bonds +suffix.html suffix +tad.html tad +temper_grem.html temper/grem +temper_npt.html temper/npt +temper.html temper +thermo_modify.html thermo_modify +thermo.html thermo +thermo_style.html thermo_style +third_order.html third_order +third_order.html third_order/kk +timer.html timer +timestep.html timestep +uncompute.html uncompute +undump.html undump +unfix.html unfix +units.html units +variable.html variable +velocity.html velocity +write_coeff.html write_coeff +write_data.html write_data +write_dump.html write_dump +write_restart.html write_restart diff --git a/tools/lammps-gui/lammpsgui.qrc b/tools/lammps-gui/lammpsgui.qrc index 40b8bd9978..caf65ffc78 100644 --- a/tools/lammps-gui/lammpsgui.qrc +++ b/tools/lammps-gui/lammpsgui.qrc @@ -1,29 +1,35 @@ - + lammps-icon-128x128.png - + + help_index.table + + + system-help.png + + gtk-zoom-in.png - + gtk-zoom-out.png - + gtk-zoom-fit.png - + edit-delete.png - + object-rotate-right.png - + object-rotate-left.png - + gtk-go-up.png - + gtk-go-down.png diff --git a/tools/lammps-gui/lammpsgui.ui b/tools/lammps-gui/lammpsgui.ui index 4032a44c31..9603fece62 100644 --- a/tools/lammps-gui/lammpsgui.ui +++ b/tools/lammps-gui/lammpsgui.ui @@ -318,6 +318,9 @@ About LAMMPS-GUI + + Ctrl+Shift+A + @@ -331,7 +334,7 @@ Quick Help - Ctrl+Shift+/ + Ctrl+Shift+H @@ -354,6 +357,9 @@ LAMMPS &Manual + + Ctrl+Shift+M + @@ -372,6 +378,9 @@ &Log Window + + Ctrl+Shift+L + @@ -381,6 +390,9 @@ &Chart Window + + Ctrl+Shift+C + @@ -415,6 +427,9 @@ &Image Window + + Ctrl+Shift+I + diff --git a/tools/lammps-gui/system-help.png b/tools/lammps-gui/system-help.png new file mode 100644 index 0000000000000000000000000000000000000000..5242b608b6142987802bdd86ca2a244a65a7a785 GIT binary patch literal 2567 zcmV+i3i$PjP)X-3iMDE&80;V^it%I zQ&FJkEvNQS?>D z?fn1u@BfHUO7SE=0-o^ai6=nXX~7S#4|~Lb@>3>iFR|_<1NpIIMWKS==Wm^izp>L& z@+cj6{a*)8fJpCsW$?A=LGKAk7G3*ttD3Ik?fb8)Z=H(E9dm%+yelBT_wx9ggR<_& z*0KsEEvtEpk9Y+616p|$UPsk9`XrYxo5=7lPK1R#X(GUytF;9| zfXC~BN9)@g0V0tnU7{aS#)r^TK@;(2B=`?I-!Qcyil&=)YV+@Un-k#obfYIXxiq5~L?x6$YAc1lo<3-r#tX6Q;x$wtYdj~3F%AMh^G=*T2EnNIk+!YsQw)Be^XeXmw(Kf zZ*)X}&ak~6|1GBazJ<_e1mb83ve?DF$G#At^Pjo@XdHL2i8^DchGcOSDF)d>8s4q| zQpyra+7`C8Gzw~p>&s&y;FaND?JXA4L0ddLZBxw08&S}`5ddcQKg)+g@7#>mIG{I~ zzb1QVf?+`(6IXV_fgR(58gkZOVv=I@A0Gj`kpO8oH_$+^VY7t>XjOvE1r4Pw9jps) zFAD`i0;<~-mAsBhp>~GbPv8y+aQTR_wwTrp{P^1NxCF^f9DaY#`GDSt#%iKsiV~^y zwJOE>OchU$pTXhNr*UoO4@f>tz*Pz3nThAne`E+gPXGd=Y->A(jr20^F3cd$J$pEU zFQ54a=GJfHlbIO|eol5EVy_%vS47$b%K9W0$~Zo87QN8`{`BE*P%2l9H7cz@2yfw2 z?Ewn8q_NW{_QD(PL*;JKSd&a8jXj^g@Fj>ii-pBoh#r;OI6!sUxfP9o@hS>bmDFrLe zdTZ=cM_(|3F!7-94rz#$?-~%22hkns#`w??+|FM%l(+uGD|1L!S8?X#b68xvhYj&I zGWk_wPWChFv_ji#ijk>xYK6G+7z8vd5E_XGsW}3a3M#s~Es@HqF>GwcP;$qhqTFUx z_!yt#Yqr$2#&}nN7!I#>eNBn67ZIX1&9!mDBtjGbm zY{fzXo71U-MoUh}^9`JGt7uiXKFxuhTkzrRiSxMj@t;xH&Nt2&8W=&zvw@Z3gQl~4 z!{bK%NKvgKfZrEjXM6!4+`Q6W?6RtNyewXIB0_LX!kBNd99e5tX2n8047mB=eSGoU zB?Nqyc!VP%B&&;UB9Wyl7#|yN^!XmX_vV8um>fRdw%)*?#sQ!CUV=PQ2kN)a6R3LC zm^2a?dooia;owLVl`O&Sh3k0n{I?Bp;^T|U^G2>vU{;AIJsfyDK3~Mc&2?i9U(5IK zz16J1&WbpM(~W4<&v7zEiR`2U+-$fQ<*G(CNg|@f0RwTt0N#n~ckt4sS8#7}7JvEs zJ1o3*7o|&n%jJxGOVtD*4jvf9kbgCI4LY6@^ z5XSh(B>ZBZA&T2t5(NfDZ4Dz6gE;;4Id+|*5q|u;{Cg;R$)PyVh=p9H2ni;RbVol> zNN69V2R4TW1`f%sB^6T7ks0uSZN7B1ZGTE#`meUzY0lA7?jjl$90~z^i+1(R@-Nrd z*K)aX+Q?@`Qon%xd#`MJZ=jf>qqia;IhP_(NzEzg*>}hfH2wWwY>i}n#|F;3LY@d* zQWxW;%vfGVl@=Kk%$Uh6x4;HQ-w6B6dC_KLYV$%vr>u5ujzzm_o_k`Bc*%(Q9Lf}J zZz)MlleoqQcpefOlMY;bz3cnFi10j-Xp}VKJ7O!|(AH*C9iz?t(AFkxXDsV$1bQh& z-@g34!cW);cQh4Bn}y1W0AgAqPK4LA03NPHvKO)^U~uhmRe0-;M;AmErLg$0vWXl| zn@tXAt&Ys`J+X}l$+Q42v%g<&_H|R{t0t&U$UpK$w@E~E4!M7|b!syxdQG355hefs dZ help_index.table