|
Peano
|
#include <TwoPunctures.h>


Public Member Functions | |
| double *_d0contig | __attribute__ ((aligned(32))) |
| double *_d0contig_low | __attribute__ ((aligned(32))) |
| TwoPunctures () | |
| void | set_initial_guess (derivs v) |
| double | TestSolution (double A, double B, double X, double R, double phi) |
| void | TestVector_w (double *par, int nvar, int n1, int n2, int n3, double *w) |
| void | Run () |
| void | Interpolate (const double *const pos, double *Q, bool low_res=false) |
| Interpolation function for an external caller. More... | |
| int | Index (int ivar, int i, int j, int k, int nvar, int n1, int n2, int n3) |
| void | allocate_derivs (derivs *v, int n) |
| void | free_derivs (derivs *v, int n) |
| void | Derivatives_AB3 (int nvar, int n1, int n2, int n3, derivs v) |
| void | F_of_v (int nvar, int n1, int n2, int n3, derivs v, double *F, derivs u) |
| void | J_times_dv (int nvar, int n1, int n2, int n3, derivs dv, double *Jdv, derivs u) |
| void | JFD_times_dv (int i, int j, int k, int nvar, int n1, int n2, int n3, derivs dv, derivs u, double *values) |
| void | SetMatrix_JFD (int nvar, int n1, int n2, int n3, derivs u, int *ncols, int **cols, double **Matrix) |
| double | PunctEvalAtArbitPosition (double *v, int ivar, double A, double B, double phi, int nvar, int n1, int n2, int n3) |
| void | calculate_derivs (int i, int j, int k, int ivar, int nvar, int n1, int n2, int n3, derivs v, derivs vv) |
| double | interpol (double a, double b, double c, derivs v) |
| double | PunctTaylorExpandAtArbitPosition (int ivar, int nvar, int n1, int n2, int n3, derivs v, double x, double y, double z) |
| double | PunctIntPolAtArbitPosition (int ivar, int nvar, int n1, int n2, int n3, derivs v, double x, double y, double z) |
| void | SpecCoef (int n1, int n2, int n3, int ivar, double *v, double *cf) |
| double | PunctEvalAtArbitPositionFast (double *v, int ivar, double A, double B, double phi, int nvar, int n1, int n2, int n3) |
| Fast Spectral Interpolation Routine Stuff. More... | |
| double | PunctEvalAtArbitPositionFaster (double A, double B, double phi) |
| double | PunctEvalAtArbitPositionFasterLowRes (double A, double B, double phi) |
| double | PunctIntPolAtArbitPositionFast (derivs v, double x, double y, double z, bool low_res=false) |
| void | AB_To_XR (int nvar, double A, double B, double *X, double *R, derivs U) |
| void | C_To_c (int nvar, double X, double R, double *x, double *r, derivs U) |
| void | rx3_To_xyz (int nvar, double x, double r, double phi, double *y, double *z, derivs U) |
| double | BY_KKofxyz (double x, double y, double z) |
| void | BY_Aijofxyz (double x, double y, double z, double Aij[3][3]) |
| void | NonLinEquations (double rho_adm, double A, double B, double X, double R, double x, double r, double phi, double y, double z, derivs U, double *values) |
| void | LinEquations (double A, double B, double X, double R, double x, double r, double phi, double y, double z, derivs dU, derivs U, double *values) |
| void | TestRelax (int nvar, int n1, int n2, int n3, derivs v, double *dv) |
| void | Newton (int nvar, int n1, int n2, int n3, derivs v, double tol, int itmax) |
| int | bicgstab (int const nvar, int const n1, int const n2, int const n3, derivs v, derivs dv, int const output, int const itmax, double const tol, double *TP_RESTRICT const normres) |
| double | norm_inf (double const *TP_RESTRICT const F, int const ntotal) |
| void | relax (double *TP_RESTRICT const dv, int const nvar, int const n1, int const n2, int const n3, double const *TP_RESTRICT const rhs, int const *TP_RESTRICT const ncols, int const *TP_RESTRICT const *TP_RESTRICT const cols, double const *TP_RESTRICT const *TP_RESTRICT const JFD) |
| void | resid (double *TP_RESTRICT const res, int const ntotal, double const *TP_RESTRICT const dv, double const *TP_RESTRICT const rhs, int const *TP_RESTRICT const ncols, int const *TP_RESTRICT const *TP_RESTRICT const cols, double const *TP_RESTRICT const *TP_RESTRICT const JFD) |
| void | LineRelax_al (double *TP_RESTRICT const dv, int const j, int const k, int const nvar, int const n1, int const n2, int const n3, double const *TP_RESTRICT const rhs, int const *TP_RESTRICT const ncols, int const *TP_RESTRICT const *TP_RESTRICT const cols, double const *TP_RESTRICT const *TP_RESTRICT const JFD) |
| void | LineRelax_be (double *TP_RESTRICT const dv, int const i, int const k, int const nvar, int const n1, int const n2, int const n3, double const *TP_RESTRICT const rhs, int const *TP_RESTRICT const ncols, int const *TP_RESTRICT const *TP_RESTRICT const cols, double const *TP_RESTRICT const *TP_RESTRICT const JFD) |
Public Member Functions inherited from TP::Parameters | |
| Parameters () | |
| void | PrintParameters () |
Public Member Functions inherited from TP::LoggingAdapter | |
| void | TP_LOG (const char *fmt,...) |
| void | TP_ERROR (const char *fmt,...) |
| void | TP_INFO (const char *fmt,...) |
| void | TP_WARN (const char *fmt,...) |
| LoggingAdapter () | |
Additional Inherited Members | |
Static Public Attributes inherited from TP::Parameters | |
| static constexpr int | npoints_A = 30 |
| static constexpr int | npoints_B = 30 |
| static constexpr int | npoints_phi = 16 |
| static constexpr int | npoints_A_low = 3 |
| static constexpr int | npoints_B_low = 3 |
| static constexpr int | npoints_phi_low = 4 |
Definition at line 47 of file TwoPunctures.h.
| TP::TwoPunctures::TwoPunctures | ( | ) |
| double* _d0contig TP::TwoPunctures::__attribute__ | ( | (aligned(32)) | ) |
| double* _d0contig_low TP::TwoPunctures::__attribute__ | ( | (aligned(32)) | ) |
| void TP::TwoPunctures::AB_To_XR | ( | int | nvar, |
| double | A, | ||
| double | B, | ||
| double * | X, | ||
| double * | R, | ||
| derivs | U | ||
| ) |
Definition at line 18 of file CoordTransf.cpp.
References TP::DERIVS::d1, TP::DERIVS::d11, TP::DERIVS::d12, TP::DERIVS::d13, TP::DERIVS::d2, TP::DERIVS::d22, TP::DERIVS::d23, and TestEllipsoidProjection::X.
| void TP::TwoPunctures::allocate_derivs | ( | derivs * | v, |
| int | n | ||
| ) |
Definition at line 52 of file FuncAndJacobian.cpp.
References TP::Utilities::dvector().

| int TP::TwoPunctures::bicgstab | ( | int const | nvar, |
| int const | n1, | ||
| int const | n2, | ||
| int const | n3, | ||
| derivs | v, | ||
| derivs | dv, | ||
| int const | output, | ||
| int const | itmax, | ||
| double const | tol, | ||
| double *TP_RESTRICT const | normres | ||
| ) |
Definition at line 277 of file Newton.cpp.
References TP::DERIVS::d0, TP::Utilities::dmatrix(), TP::Utilities::dvector(), TP::Utilities::free_dmatrix(), TP::Utilities::free_dvector(), TP::Utilities::free_imatrix(), TP::Utilities::free_ivector(), TP::Utilities::imatrix(), TP::Utilities::ivector(), euler::j, TP::Utilities::norm2(), TP::NRELAX, artificial-tsunami::output, acoustic::p, acoustic::rho, aderdg::s, TP::Utilities::scalarproduct(), TP::StencilSize, acoustic::t, euler::u, and acoustic::v.

| void TP::TwoPunctures::BY_Aijofxyz | ( | double | x, |
| double | y, | ||
| double | z, | ||
| double | Aij[3][3] | ||
| ) |
Definition at line 83 of file Equations.cpp.
References euler::j, ModeCalc::x, and csv_to_plot::y.
| double TP::TwoPunctures::BY_KKofxyz | ( | double | x, |
| double | y, | ||
| double | z | ||
| ) |
Definition at line 25 of file Equations.cpp.
References euler::j, ModeCalc::x, and csv_to_plot::y.
| void TP::TwoPunctures::C_To_c | ( | int | nvar, |
| double | X, | ||
| double | R, | ||
| double * | x, | ||
| double * | r, | ||
| derivs | U | ||
| ) |
Definition at line 53 of file CoordTransf.cpp.
References acoustic::c, TP::DERIVS::d1, TP::DERIVS::d11, TP::DERIVS::d12, TP::DERIVS::d13, TP::DERIVS::d2, TP::DERIVS::d22, TP::DERIVS::d23, ModeCalc::x, and TestEllipsoidProjection::X.
| void TP::TwoPunctures::calculate_derivs | ( | int | i, |
| int | j, | ||
| int | k, | ||
| int | ivar, | ||
| int | nvar, | ||
| int | n1, | ||
| int | n2, | ||
| int | n3, | ||
| derivs | v, | ||
| derivs | vv | ||
| ) |
Definition at line 727 of file FuncAndJacobian.cpp.
References TP::DERIVS::d0, TP::DERIVS::d1, TP::DERIVS::d11, TP::DERIVS::d12, TP::DERIVS::d13, TP::DERIVS::d2, TP::DERIVS::d22, TP::DERIVS::d23, TP::DERIVS::d3, TP::DERIVS::d33, euler::j, and acoustic::v.
| void TP::TwoPunctures::Derivatives_AB3 | ( | int | nvar, |
| int | n1, | ||
| int | n2, | ||
| int | n3, | ||
| derivs | v | ||
| ) |
Definition at line 86 of file FuncAndJacobian.cpp.
References TP::Utilities::chder(), TP::Utilities::chebft_Zeros(), performance_testbed::dr, TP::Utilities::dvector(), TP::Utilities::fourder(), TP::Utilities::fourder2(), TP::Utilities::fourft(), TP::Utilities::free_dvector(), TP::Utilities::free_ivector(), TP::Utilities::ivector(), euler::j, TP::Utilities::maximum3(), acoustic::p, and acoustic::v.

Definition at line 194 of file FuncAndJacobian.cpp.
References TP::DERIVS::d0, TP::DERIVS::d1, TP::DERIVS::d11, TP::DERIVS::d12, TP::DERIVS::d13, TP::DERIVS::d2, TP::DERIVS::d22, TP::DERIVS::d23, TP::DERIVS::d3, TP::DERIVS::d33, TP::Utilities::dvector(), TP::Utilities::free_dvector(), euler::j, TP::TP_MyProc(), euler::u, acoustic::v, ModeCalc::x, TestEllipsoidProjection::X, and csv_to_plot::y.

| void TP::TwoPunctures::free_derivs | ( | derivs * | v, |
| int | n | ||
| ) |
Definition at line 69 of file FuncAndJacobian.cpp.
References TP::Utilities::free_dvector().

| int TP::TwoPunctures::Index | ( | int | ivar, |
| int | i, | ||
| int | j, | ||
| int | k, | ||
| int | nvar, | ||
| int | n1, | ||
| int | n2, | ||
| int | n3 | ||
| ) |
Definition at line 28 of file FuncAndJacobian.cpp.
References euler::j.
| double TP::TwoPunctures::interpol | ( | double | a, |
| double | b, | ||
| double | c, | ||
| derivs | v | ||
| ) |
Definition at line 751 of file FuncAndJacobian.cpp.
References swe::b, acoustic::c, and acoustic::v.
| void TP::TwoPunctures::Interpolate | ( | const double *const | pos, |
| double * | Q, | ||
| bool | low_res = false |
||
| ) |
Interpolation function for an external caller.
psi[ind] = static_psi;
psix[ind] = px / static_psi; psiy[ind] = py / static_psi; psiz[ind] = pz / static_psi;
psixx[ind] = pxx / static_psi; psixy[ind] = pxy / static_psi; psixz[ind] = pxz / static_psi; psiyy[ind] = pyy / static_psi; psiyz[ind] = pyz / static_psi; psizz[ind] = pzz / static_psi;
puncture_u[ind] = U; /// @TODO: Also no storage for this
SWAP (psix[ind], psiz[ind]);
SWAP (psixx[ind], psizz[ind]); SWAP (psixy[ind], psiyz[ind]);
Definition at line 421 of file TwoPunctures.cpp.
References TP::Utilities::free_dvector(), TP::Z4VectorShortcuts::g11, TP::Z4VectorShortcuts::g12, TP::Z4VectorShortcuts::g13, TP::Z4VectorShortcuts::g22, TP::Z4VectorShortcuts::g23, TP::Z4VectorShortcuts::g33, TP::GSM_evaluation, TP::GSM_Taylor_expansion, TP::Z4VectorShortcuts::K11, TP::Z4VectorShortcuts::K12, TP::Z4VectorShortcuts::K13, TP::Z4VectorShortcuts::K22, TP::Z4VectorShortcuts::K23, TP::Z4VectorShortcuts::K33, TP::Z4VectorShortcuts::lapse, acoustic::p, TP::Z4VectorShortcuts::Qlen, euler::u, acoustic::v, ModeCalc::x, and csv_to_plot::y.
Referenced by applications::exahype2::ccz4::ApplyTwoPunctures(), and TP_bindding::GradientCal().


| void TP::TwoPunctures::J_times_dv | ( | int | nvar, |
| int | n1, | ||
| int | n2, | ||
| int | n3, | ||
| derivs | dv, | ||
| double * | Jdv, | ||
| derivs | u | ||
| ) |
Definition at line 372 of file FuncAndJacobian.cpp.
References TP::DERIVS::d0, TP::DERIVS::d1, TP::DERIVS::d11, TP::DERIVS::d12, TP::DERIVS::d13, TP::DERIVS::d2, TP::DERIVS::d22, TP::DERIVS::d23, TP::DERIVS::d3, TP::DERIVS::d33, TP::Utilities::dvector(), TP::Utilities::free_dvector(), euler::j, euler::u, ModeCalc::x, TestEllipsoidProjection::X, and csv_to_plot::y.

| void TP::TwoPunctures::JFD_times_dv | ( | int | i, |
| int | j, | ||
| int | k, | ||
| int | nvar, | ||
| int | n1, | ||
| int | n2, | ||
| int | n3, | ||
| derivs | dv, | ||
| derivs | u, | ||
| double * | values | ||
| ) |
Definition at line 452 of file FuncAndJacobian.cpp.
References TP::DERIVS::d0, TP::DERIVS::d1, TP::DERIVS::d11, TP::DERIVS::d12, TP::DERIVS::d13, TP::DERIVS::d2, TP::DERIVS::d22, TP::DERIVS::d23, TP::DERIVS::d3, TP::DERIVS::d33, euler::j, euler::u, ModeCalc::x, TestEllipsoidProjection::X, and csv_to_plot::y.
| void TP::TwoPunctures::LinEquations | ( | double | A, |
| double | B, | ||
| double | X, | ||
| double | R, | ||
| double | x, | ||
| double | r, | ||
| double | phi, | ||
| double | y, | ||
| double | z, | ||
| derivs | dU, | ||
| derivs | U, | ||
| double * | values | ||
| ) |
Definition at line 181 of file Equations.cpp.
References TP::DERIVS::d0, TP::DERIVS::d11, TP::DERIVS::d22, TP::DERIVS::d33, ModeCalc::x, and csv_to_plot::y.
| void TP::TwoPunctures::LineRelax_al | ( | double *TP_RESTRICT const | dv, |
| int const | j, | ||
| int const | k, | ||
| int const | nvar, | ||
| int const | n1, | ||
| int const | n2, | ||
| int const | n3, | ||
| double const *TP_RESTRICT const | rhs, | ||
| int const *TP_RESTRICT const | ncols, | ||
| int const *TP_RESTRICT const *TP_RESTRICT const | cols, | ||
| double const *TP_RESTRICT const *TP_RESTRICT const | JFD | ||
| ) |
Definition at line 57 of file Newton.cpp.
References swe::b, fuseADERSolvers::f, euler::j, and ModeCalc::x.
| void TP::TwoPunctures::LineRelax_be | ( | double *TP_RESTRICT const | dv, |
| int const | i, | ||
| int const | k, | ||
| int const | nvar, | ||
| int const | n1, | ||
| int const | n2, | ||
| int const | n3, | ||
| double const *TP_RESTRICT const | rhs, | ||
| int const *TP_RESTRICT const | ncols, | ||
| int const *TP_RESTRICT const *TP_RESTRICT const | cols, | ||
| double const *TP_RESTRICT const *TP_RESTRICT const | JFD | ||
| ) |
Definition at line 117 of file Newton.cpp.
References swe::b, fuseADERSolvers::f, euler::j, and ModeCalc::x.
| void TP::TwoPunctures::Newton | ( | int | nvar, |
| int | n1, | ||
| int | n2, | ||
| int | n3, | ||
| derivs | v, | ||
| double | tol, | ||
| int | itmax | ||
| ) |
Definition at line 452 of file Newton.cpp.
References TP::DERIVS::d0, TP::Utilities::dvector(), TP::Utilities::free_dvector(), euler::j, euler::u, and acoustic::v.

| void TP::TwoPunctures::NonLinEquations | ( | double | rho_adm, |
| double | A, | ||
| double | B, | ||
| double | X, | ||
| double | R, | ||
| double | x, | ||
| double | r, | ||
| double | phi, | ||
| double | y, | ||
| double | z, | ||
| derivs | U, | ||
| double * | values | ||
| ) |
Definition at line 153 of file Equations.cpp.
References TP::DERIVS::d0, TP::DERIVS::d11, TP::DERIVS::d22, TP::DERIVS::d33, elastic::mu, ModeCalc::x, and csv_to_plot::y.
| double TP::TwoPunctures::norm_inf | ( | double const *TP_RESTRICT const | F, |
| int const | ntotal | ||
| ) |
Definition at line 22 of file Newton.cpp.
References euler::j.
| double TP::TwoPunctures::PunctEvalAtArbitPosition | ( | double * | v, |
| int | ivar, | ||
| double | A, | ||
| double | B, | ||
| double | phi, | ||
| int | nvar, | ||
| int | n1, | ||
| int | n2, | ||
| int | n3 | ||
| ) |
Definition at line 685 of file FuncAndJacobian.cpp.
References TP::Utilities::chebev(), TP::Utilities::chebft_Zeros(), TP::Utilities::dmatrix(), TP::Utilities::dvector(), TP::Utilities::fourev(), TP::Utilities::fourft(), TP::Utilities::free_dmatrix(), TP::Utilities::free_dvector(), euler::j, TP::Utilities::maximum3(), acoustic::p, and acoustic::v.

| double TP::TwoPunctures::PunctEvalAtArbitPositionFast | ( | double * | v, |
| int | ivar, | ||
| double | A, | ||
| double | B, | ||
| double | phi, | ||
| int | nvar, | ||
| int | n1, | ||
| int | n2, | ||
| int | n3 | ||
| ) |
Fast Spectral Interpolation Routine Stuff.
Definition at line 853 of file FuncAndJacobian.cpp.
References TP::Utilities::chebev(), TP::Utilities::dmatrix(), TP::Utilities::dvector(), TP::Utilities::fourev(), TP::Utilities::free_dmatrix(), TP::Utilities::free_dvector(), euler::j, TP::Utilities::maximum3(), acoustic::p, and acoustic::v.

| double TP::TwoPunctures::PunctEvalAtArbitPositionFaster | ( | double | A, |
| double | B, | ||
| double | phi | ||
| ) |
Definition at line 921 of file FuncAndJacobian.cpp.
References TP::chebev_wrec(), TP::Utilities::fourev(), euler::j, acoustic::p, and TP::recurrence().

| double TP::TwoPunctures::PunctEvalAtArbitPositionFasterLowRes | ( | double | A, |
| double | B, | ||
| double | phi | ||
| ) |
Definition at line 966 of file FuncAndJacobian.cpp.
References TP::chebev_wrec(), TP::Utilities::fourev(), euler::j, acoustic::p, and TP::recurrence().

| double TP::TwoPunctures::PunctIntPolAtArbitPosition | ( | int | ivar, |
| int | nvar, | ||
| int | n1, | ||
| int | n2, | ||
| int | n3, | ||
| derivs | v, | ||
| double | x, | ||
| double | y, | ||
| double | z | ||
| ) |
Definition at line 813 of file FuncAndJacobian.cpp.
References TP::min(), acoustic::v, ModeCalc::x, TestEllipsoidProjection::X, csv_to_plot::y, and ModeCalc::zs.

| double TP::TwoPunctures::PunctIntPolAtArbitPositionFast | ( | derivs | v, |
| double | x, | ||
| double | y, | ||
| double | z, | ||
| bool | low_res = false |
||
| ) |
Definition at line 1027 of file FuncAndJacobian.cpp.
References TP::min(), ModeCalc::x, TestEllipsoidProjection::X, csv_to_plot::y, and ModeCalc::zs.

| double TP::TwoPunctures::PunctTaylorExpandAtArbitPosition | ( | int | ivar, |
| int | nvar, | ||
| int | n1, | ||
| int | n2, | ||
| int | n3, | ||
| derivs | v, | ||
| double | x, | ||
| double | y, | ||
| double | z | ||
| ) |
Definition at line 762 of file FuncAndJacobian.cpp.
References swe::b, acoustic::c, euler::j, TP::min(), acoustic::v, ModeCalc::x, TestEllipsoidProjection::X, csv_to_plot::y, and ModeCalc::zs.

| void TP::TwoPunctures::relax | ( | double *TP_RESTRICT const | dv, |
| int const | nvar, | ||
| int const | n1, | ||
| int const | n2, | ||
| int const | n3, | ||
| double const *TP_RESTRICT const | rhs, | ||
| int const *TP_RESTRICT const | ncols, | ||
| int const *TP_RESTRICT const *TP_RESTRICT const | cols, | ||
| double const *TP_RESTRICT const *TP_RESTRICT const | JFD | ||
| ) |
Definition at line 176 of file Newton.cpp.
References euler::j, and TP::N_PlaneRelax.
| void TP::TwoPunctures::resid | ( | double *TP_RESTRICT const | res, |
| int const | ntotal, | ||
| double const *TP_RESTRICT const | dv, | ||
| double const *TP_RESTRICT const | rhs, | ||
| int const *TP_RESTRICT const | ncols, | ||
| int const *TP_RESTRICT const *TP_RESTRICT const | cols, | ||
| double const *TP_RESTRICT const *TP_RESTRICT const | JFD | ||
| ) |
Definition at line 38 of file Newton.cpp.
| void TP::TwoPunctures::Run | ( | ) |
Definition at line 189 of file TwoPunctures.cpp.
References TP::Utilities::dvector(), TP::GSM_evaluation, TP::GSM_Taylor_expansion, euler::j, euler::u, and acoustic::v.
Referenced by applications::exahype2::ccz4::CCZ4::prepare(), benchmarks::exahype2::ccz4::CCZ4::prepare(), and benchmarks::exahype2::ccz4::prepareTwoPunctures().


| void TP::TwoPunctures::rx3_To_xyz | ( | int | nvar, |
| double | x, | ||
| double | r, | ||
| double | phi, | ||
| double * | y, | ||
| double * | z, | ||
| derivs | U | ||
| ) |
Definition at line 116 of file CoordTransf.cpp.
References TP::DERIVS::d1, TP::DERIVS::d11, TP::DERIVS::d12, TP::DERIVS::d13, TP::DERIVS::d2, TP::DERIVS::d22, TP::DERIVS::d23, TP::DERIVS::d3, TP::DERIVS::d33, and csv_to_plot::y.
| void TP::TwoPunctures::set_initial_guess | ( | derivs | v | ) |
Definition at line 16 of file TwoPunctures.cpp.
References TP::DERIVS::d0, TP::DERIVS::d1, TP::DERIVS::d11, TP::DERIVS::d12, TP::DERIVS::d13, TP::DERIVS::d2, TP::DERIVS::d22, TP::DERIVS::d23, TP::DERIVS::d3, TP::DERIVS::d33, euler::j, TP::TP_MyProc(), acoustic::v, and TestEllipsoidProjection::X.

| void TP::TwoPunctures::SetMatrix_JFD | ( | int | nvar, |
| int | n1, | ||
| int | n2, | ||
| int | n3, | ||
| derivs | u, | ||
| int * | ncols, | ||
| int ** | cols, | ||
| double ** | Matrix | ||
| ) |
Definition at line 594 of file FuncAndJacobian.cpp.
References TP::DERIVS::d0, TP::Utilities::dvector(), TP::Utilities::free_dvector(), euler::j, TP::Utilities::maximum2(), TP::Utilities::minimum2(), and euler::u.

| void TP::TwoPunctures::SpecCoef | ( | int | n1, |
| int | n2, | ||
| int | n3, | ||
| int | ivar, | ||
| double * | v, | ||
| double * | cf | ||
| ) |
Definition at line 1061 of file FuncAndJacobian.cpp.
References TP::Utilities::chebft_Zeros(), TP::Utilities::d3tensor(), TP::Utilities::dvector(), TP::Utilities::fourft(), TP::Utilities::free_d3tensor(), TP::Utilities::free_dvector(), euler::j, TP::Utilities::maximum3(), acoustic::p, and acoustic::v.

| void TP::TwoPunctures::TestRelax | ( | int | nvar, |
| int | n1, | ||
| int | n2, | ||
| int | n3, | ||
| derivs | v, | ||
| double * | dv | ||
| ) |
Definition at line 225 of file Newton.cpp.
References TP::Utilities::dmatrix(), TP::Utilities::dvector(), TP::Utilities::free_dmatrix(), TP::Utilities::free_dvector(), TP::Utilities::free_imatrix(), TP::Utilities::free_ivector(), TP::Utilities::imatrix(), TP::Utilities::ivector(), euler::j, TP::Utilities::norm1(), TP::NRELAX, TP::StencilSize, TP::Step_Relax, euler::u, and acoustic::v.

| double TP::TwoPunctures::TestSolution | ( | double | A, |
| double | B, | ||
| double | X, | ||
| double | R, | ||
| double | phi | ||
| ) |
| void TP::TwoPunctures::TestVector_w | ( | double * | par, |
| int | nvar, | ||
| int | n1, | ||
| int | n2, | ||
| int | n3, | ||
| double * | w | ||
| ) |
| int TP::TwoPunctures::_n1_low |
Definition at line 56 of file TwoPunctures.h.
| int TP::TwoPunctures::_n2_low |
Definition at line 56 of file TwoPunctures.h.
| int TP::TwoPunctures::_n3_low |
Definition at line 56 of file TwoPunctures.h.
| int TP::TwoPunctures::antisymmetric_lapse |
Definition at line 58 of file TwoPunctures.h.
| int TP::TwoPunctures::averaged_lapse |
Definition at line 58 of file TwoPunctures.h.
| int TP::TwoPunctures::brownsville_lapse |
Definition at line 58 of file TwoPunctures.h.
| derivs TP::TwoPunctures::cf_v |
Definition at line 57 of file TwoPunctures.h.
| GRID_SETUP_METHOD TP::TwoPunctures::gsm |
Definition at line 54 of file TwoPunctures.h.
| int TP::TwoPunctures::n1 |
Definition at line 55 of file TwoPunctures.h.
Referenced by TwoPunctures().
| int TP::TwoPunctures::n2 |
Definition at line 55 of file TwoPunctures.h.
Referenced by TwoPunctures().
| int TP::TwoPunctures::n3 |
Definition at line 55 of file TwoPunctures.h.
Referenced by TwoPunctures().
| int TP::TwoPunctures::nvar |
Definition at line 55 of file TwoPunctures.h.
Referenced by TwoPunctures().
| int TP::TwoPunctures::pmn_lapse |
Definition at line 58 of file TwoPunctures.h.
| bool TP::TwoPunctures::runned |
| derivs TP::TwoPunctures::u |
Definition at line 57 of file TwoPunctures.h.
| derivs TP::TwoPunctures::v |
Definition at line 57 of file TwoPunctures.h.