रीमैन थीटा फ़ंक्शन के एक विशेष मामले का अनुमान लगाना


27

यह चुनौती तेज कोड लिखना है जो एक कम्प्यूटेशनल रूप से कठिन अनंत राशि का प्रदर्शन कर सकता है।

इनपुट

एक nसे nमैट्रिक्स Pपूर्णांक प्रविष्टियों से छोटे हैं साथ 100निरपेक्ष मूल्य में। परीक्षण करते समय मैं आपके कोड को किसी भी समझदार प्रारूप में आपके कोड को इनपुट प्रदान करने में प्रसन्न हूं। डिफ़ॉल्ट मैट्रिक्स की एक पंक्ति प्रति पंक्ति होगी, अंतरिक्ष को अलग किया जाएगा और मानक इनपुट पर प्रदान किया जाएगा।

Pहो जाएगा सकारात्मक निश्चित अर्थ है जो यह हमेशा सममित हो जाएगा। इसके अलावा, आपको वास्तव में यह जानने की जरूरत नहीं है कि चुनौती का जवाब देने के लिए सकारात्मक परिभाषा का क्या मतलब है। हालांकि इसका मतलब यह है कि वास्तव में नीचे परिभाषित राशि का जवाब होगा।

हालांकि आपको यह जानना होगा कि मैट्रिक्स-वेक्टर उत्पाद क्या है।

उत्पादन

आपके कोड को अनंत राशि की गणना करनी चाहिए:

यहाँ छवि विवरण दर्ज करें

सही उत्तर के प्लस या माइनस 0.0001 के भीतर। यहाँ Zपूर्णांकों का सेट है और इतने Z^nके साथ सभी संभव वैक्टर है nपूर्णांक तत्वों और eहै प्रसिद्ध गणितीय स्थिरांक है कि लगभग २.७१८२८ बराबर होती है। ध्यान दें कि घातांक में मान बस एक संख्या है। एक स्पष्ट उदाहरण के लिए नीचे देखें।

यह रीमैन थीटा फ़ंक्शन से कैसे संबंधित है?

इस पेपर की संकेतन में हम रीमैन थीटा फ़ंक्शन की गणना करने की कोशिश कर रहे हैं यहाँ छवि विवरण दर्ज करें। हमारी समस्या कम से कम दो कारणों से एक विशेष मामला है।

  • हमने प्रारंभिक पैरामीटर zको लिंक किए गए पेपर में 0 पर सेट किया है।
  • हम मैट्रिक्स Pको इस तरह से बनाते हैं कि एक eigenvalue का न्यूनतम आकार होता है 1। (मैट्रिक्स कैसे बनाया जाता है, इसके लिए नीचे देखें।)

उदाहरण

P = [[ 5.,  2.,  0.,  0.],
     [ 2.,  5.,  2., -2.],
     [ 0.,  2.,  5.,  0.],
     [ 0., -2.,  0.,  5.]]

Output: 1.07551411208

अधिक विस्तार से, हमें इस P के लिए राशि में सिर्फ एक शब्द दिखाई देता है। उदाहरण के लिए योग में केवल एक पद लें:

यहाँ छवि विवरण दर्ज करें

और x^T P x = 30। जो सूचना दी गई है e^(-30), उसके बारे 10^(-14)में दी गई सहिष्णुता का सही उत्तर पाने के लिए महत्वपूर्ण होने की संभावना नहीं है। याद रखें कि अनंत योग वास्तव में लंबाई 4 के हर संभव वेक्टर का उपयोग करेगा जहां तत्व पूर्णांक हैं। मैंने केवल एक स्पष्ट उदाहरण दिया।

P = [[ 5.,  2.,  2.,  2.],
     [ 2.,  5.,  4.,  4.],
     [ 2.,  4.,  5.,  4.],
     [ 2.,  4.,  4.,  5.]]

Output = 1.91841190706

P = [[ 6., -3.,  3., -3.,  3.],
     [-3.,  6., -5.,  5., -5.],
     [ 3., -5.,  6., -5.,  5.],
     [-3.,  5., -5.,  6., -5.],
     [ 3., -5.,  5., -5.,  6.]]

Output = 2.87091065342

P = [[6., -1., -3., 1., 3., -1., -3., 1., 3.],
     [-1., 6., -1., -5., 1., 5., -1., -5., 1.],
     [-3., -1., 6., 1., -5., -1., 5., 1., -5.],
     [1., -5., 1., 6., -1., -5., 1., 5., -1.],
     [3., 1., -5., -1., 6., 1., -5., -1., 5.],
     [-1., 5., -1., -5., 1., 6., -1., -5., 1.],
     [-3., -1., 5., 1., -5., -1., 6., 1., -5.],
     [1., -5., 1., 5., -1., -5., 1., 6., -1.],
     [3., 1., -5., -1., 5., 1., -5., -1., 6.]]

Output: 8.1443647932

P = [[ 7.,  2.,  0.,  0.,  6.,  2.,  0.,  0.,  6.],
     [ 2.,  7.,  0.,  0.,  2.,  6.,  0.,  0.,  2.],
     [ 0.,  0.,  7., -2.,  0.,  0.,  6., -2.,  0.],
     [ 0.,  0., -2.,  7.,  0.,  0., -2.,  6.,  0.],
     [ 6.,  2.,  0.,  0.,  7.,  2.,  0.,  0.,  6.],
     [ 2.,  6.,  0.,  0.,  2.,  7.,  0.,  0.,  2.],
     [ 0.,  0.,  6., -2.,  0.,  0.,  7., -2.,  0.],
     [ 0.,  0., -2.,  6.,  0.,  0., -2.,  7.,  0.],
     [ 6.,  2.,  0.,  0.,  6.,  2.,  0.,  0.,  7.]]

Output = 3.80639191181

स्कोर

मैं आपके कोड को आकार के बेतरतीब ढंग से चुने गए मैट्रिसेस पी पर परीक्षण करूँगा।

आपका स्कोर केवल सबसे बड़ा है n, जिसके लिए मुझे 30 सेकंड से भी कम समय में एक सही उत्तर मिलता है, जब Pउस आकार के बेतरतीब ढंग से चुने गए मैट्रिस के साथ 5 से अधिक रन औसत होते हैं।

एक टाई के बारे में क्या?

यदि कोई टाई है, तो विजेता वह होगा जिसका कोड सबसे तेजी से औसतन 5 रन से अधिक होगा। इस घटना में कि वे समय भी बराबर हैं, विजेता पहला जवाब है।

यादृच्छिक इनपुट कैसे बनाया जाएगा?

  1. M <= n और एंट्री के साथ n मैट्रिक्स से M को एक यादृच्छिक m होने दें और जो -1 या 1. पायथन / संख्या में हैं M = np.random.choice([0,1], size = (m,n))*2-1। व्यवहार में मैं इसके mबारे में होना चाहूंगा n/2
  2. आइये P पहचान चिन्ह + M ^ T M. In Python / numpy हो P =np.identity(n)+np.dot(M.T,M)। अब हमें गारंटी दी गई है कि Pसकारात्मक निश्चितता है और प्रविष्टियां एक उपयुक्त सीमा में हैं।

ध्यान दें कि इसका मतलब है कि पी के सभी eigenvalues ​​कम से कम 1 हैं, जिससे समस्या को रीमैन थीटा फ़ंक्शन को अनुमानित करने की सामान्य समस्या की तुलना में संभावित रूप से आसान हो जाता है।

भाषा और पुस्तकालय

आप अपनी पसंद की किसी भी भाषा या लाइब्रेरी का उपयोग कर सकते हैं। हालाँकि, स्कोरिंग के प्रयोजनों के लिए, मैं आपके कोड को अपनी मशीन पर चलाऊंगा ताकि कृपया इसे उबंटू पर चलाने के लिए स्पष्ट निर्देश प्रदान करें।

माई मशीन द टाइमिंग मेरी मशीन पर चलाई जाएगी। यह एक 8 जीबी एएमडी एफएक्स -8350 ईट-कोर प्रोसेसर पर एक मानक उबंटू स्थापित है। इसका मतलब यह भी है कि मुझे आपका कोड चलाने में सक्षम होना चाहिए।


उत्तर देना

  • n = 47में सी ++ टन Hospel द्वारा
  • n = 8माल्टीसेन द्वारा पायथन में

यह उल्लेखनीय है कि परिभाषा के अनुसार एक सकारात्मक निश्चित मैट्रिक्स सममित है।
२०१२ आर्कैंपियन

@ 2012 आर्केड धन्यवाद। जोड़ा गया।

ठीक है, शायद यह एक मूक सवाल है, लेकिन मैं उम्र के लिए इस तरह से घूरे है और मैं समझ नहीं है कि कैसे आप एक मिल xकी [-1,0,2,1]। क्या आप इसे विस्तार से बताएंगे? (संकेत: मैं गणित गुरु नहीं हूं)
wnnmaw 19

@wnnmaw भ्रमित होने के लिए क्षमा करें। इस मामले में लंबाई 4 के हर संभव वेक्टर x के लिए एक शब्द है । [-1,0,2,1] सिर्फ एक है जिसे मैंने यादृच्छिक रूप से यह दिखाने के लिए उठाया कि उस स्थिति में यह शब्द क्या होगा।

1
@Lembik जिस तरह से आप SPD मैट्रिसेस उत्पन्न करते हैं उसका तात्पर्य है कि किसी भी विलक्षण मूल्य का कभी भी निरपेक्ष मान नहीं होता है। 1. क्या हम इस ज्ञान का उपयोग कर सकते हैं?
दोष

जवाबों:


15

सी ++

कोई और अधिक भोली दृष्टिकोण। केवल दीर्घवृत्त के अंदर का मूल्यांकन करें।

Armadillo, ntl, gsl और pthread लाइब्रेरी का उपयोग करता है। का उपयोग कर स्थापित करें

apt-get install libarmadillo-dev libntl-dev libgsl-dev

कुछ का उपयोग करके कार्यक्रम को संकलित करें:

g++ -Wall -std=c++11 -O3 -fno-math-errno -funsafe-math-optimizations -ffast-math -fno-signed-zeros -fno-trapping-math -fomit-frame-pointer -march=native -s infinity.cpp -larmadillo -lntl -lgsl -lpthread -o infinity

कुछ सिस्टम पर आपको -lgslcblasबाद में जोड़ना पड़ सकता है -lgsl

STDIN पर तत्वों द्वारा पीछा मैट्रिक्स के आकार के साथ चलाएँ:

./infinity < matrix.txt

matrix.txt:

4
5  2  0  0
2  5  2 -2
0  2  5  0
0 -2  0  5

या 1e-5 की सटीकता की कोशिश करने के लिए:

./infinity -p 1e-5 < matrix.txt

infinity.cpp:

// Based on http://arxiv.org/abs/nlin/0206009

#include <iostream>
#include <vector>
#include <stdexcept>
#include <cstdlib>
#include <cmath>
#include <string>
#include <thread>
#include <future>
#include <chrono>

using namespace std;

#include <getopt.h>

#include <armadillo>

using namespace arma;

#include <NTL/mat_ZZ.h>
#include <NTL/LLL.h>

using namespace NTL;

#include <gsl/gsl_sf_gamma.h>
#include <gsl/gsl_errno.h>
#include <gsl/gsl_roots.h>

double const EPSILON = 1e-4;       // default precision
double const GROW    = 2;          // By how much we grow the ellipsoid volume
double const UPSCALE = 1e9;        // lattice reduction, upscale real to integer
double const THREAD_SEC = 0.1;     // Use threads if need more time than this
double const RADIUS_MAX = 1e6;     // Maximum radius used in root finding
double const RADIUS_INTERVAL = 1e-6; // precision of target radius
int const ITER_MAX = 1000;         // Maximum iterations in root finding
unsigned long POINTS_MIN = 1000;   // Minimum points before getting fancy

struct Result {
    Result& operator+=(Result const& add) {
        sum     += add.sum;
        elapsed += add.elapsed;
        points  += add.points;
        return *this;
    }

    friend Result operator-(Result const& left, Result const& right) {
        return Result{left.sum - right.sum,
                left.elapsed - right.elapsed,
                left.points - right.points};
    }

    double sum, elapsed;
    unsigned long points;
};

struct Params {
    double half_rho, half_N, epsilon;
};

double fill_factor_error(double r, void *void_params) {
    auto params = static_cast<Params*>(void_params);
    r -= params->half_rho;
    return gsl_sf_gamma_inc(params->half_N, r*r) - params->epsilon;
}

// Calculate radius needed for target precision
double radius(int N, double rho, double lat_det, double epsilon) {
    Params params;

    params.half_rho = rho / 2.;
    params.half_N   = N   / 2.;
    params.epsilon = epsilon*lat_det*gsl_sf_gamma(params.half_N)/pow(M_PI, params.half_N);

    // Calculate minimum allowed radius
    auto r = sqrt(params.half_N)+params.half_rho;
    auto val = fill_factor_error(r, &params);
    cout << "Minimum R=" << r << " -> " << val << endl;

    if (val > 0) {
        // The minimum radius is not good enough. Work out a better one by
        // finding the root of a tricky function
        auto low  = r;
        auto high = RADIUS_MAX * 2 * params.half_rho;
        auto val = fill_factor_error(high, &params);
        if (val >= 0)
            throw(logic_error("huge RADIUS_MAX is still not big enough"));

        gsl_function F;
        F.function = fill_factor_error;
        F.params   = &params;

        auto T = gsl_root_fsolver_brent;
        auto s = gsl_root_fsolver_alloc (T);
        gsl_root_fsolver_set (s, &F, low, high);

        int status = GSL_CONTINUE;
        for (auto iter=1; status == GSL_CONTINUE && iter <= ITER_MAX; ++iter) {
            gsl_root_fsolver_iterate (s);
            low  = gsl_root_fsolver_x_lower (s);
            high = gsl_root_fsolver_x_upper (s);
            status = gsl_root_test_interval(low, high, 0, RADIUS_INTERVAL  * 2 * params.half_rho);
        }
        r = gsl_root_fsolver_root(s);
        gsl_root_fsolver_free(s);
        if (status == GSL_CONTINUE)
            throw(logic_error("Search for R did not converge"));
    }
    return r;
}

// Recursively walk down the ellipsoids in each dimension
void ellipsoid(int d, mat const& A, double const* InvD, mat& Accu,
               Result& result, double r2) {
    auto r = sqrt(r2);
    auto offset = Accu(d, d);
    // InvD[d] = 1/ A(d, d)
    auto from = ceil((-r-offset) * InvD[d]);
    auto to   = floor((r-offset) * InvD[d]);
    for (auto v = from; v <= to; ++v) {
        auto value  = v * A(d, d)+offset;
        auto residu = r2 - value*value;
        if (d == 0) {
            result.sum += exp(residu);
            ++result.points;
        } else {
            for (auto i=0; i<d; ++i) Accu(d-1, i) = Accu(d, i) + v * A(d, i);
            ellipsoid(d-1, A, InvD, Accu, result, residu);
        }
    }
}

// Specialised version of ellipsoid() that will only process points an octant
void ellipsoid(int d, mat const& A, double const* InvD, mat& Accu,
               Result& result, double r2, unsigned int octant) {
    auto r = sqrt(r2);
    auto offset = Accu(d, d);
    // InvD[d] = 1/ A(d, d)
    long from = ceil((-r-offset) * InvD[d]);
    long to   = floor((r-offset) * InvD[d]);
    auto points = to-from+1;
    auto base = from + points/2;
    if (points & 1) {
        auto value = base * A(d, d) + offset;
        auto residu = r2 - value * value;
        if (d == 0) {
            if ((octant & (octant - 1)) == 0) {
                result.sum += exp(residu);
                ++result.points;
            }
        } else {
            for (auto i=0; i<d; ++i) Accu(d-1, i) = Accu(d, i) + base * A(d, i);
            ellipsoid(d-1, A, InvD, Accu, result, residu, octant);
        }
        ++base;
    }
    if ((octant & 1) == 0) {
        to = from + points / 2 - 1;
        base = from;
    }
    octant /= 2;
    for (auto v = base; v <= to; ++v) {
        auto value = v * A(d,d)+offset;
        auto residu = r2 - value*value;
        if (d == 0) {
            if ((octant & (octant - 1)) == 0) {
                result.sum += exp(residu);
                ++result.points;
            }
        } else {
            for (auto i=0; i<d; ++i) Accu(d-1, i) = Accu(d, i) + v * A(d, i);
            if (octant == 1)
                ellipsoid(d-1, A, InvD, Accu, result, residu);
            else
                ellipsoid(d-1, A, InvD, Accu, result, residu, octant);
        }
    }
}

// Prepare call to ellipsoid()
Result sym_ellipsoid(int N, mat const& A, const vector<double>& InvD, double r,
                     unsigned int octant = 1) {
    auto start = chrono::steady_clock::now();
    auto r2 = r*r;

    mat Accu(N, N);
    Accu.row(N-1).zeros();

    Result result{0, 0, 0};
    // 2*octant+1 forces the points into the upper half plane, skipping 0
    // This way we use the lattice symmetry and calculate only half the points
    ellipsoid(N-1, A, &InvD[0], Accu, result, r2, 2*octant+1);
    // Compensate for the extra factor exp(r*r) we always add in ellipsoid()
    result.sum /= exp(r2);
    auto end = chrono::steady_clock::now();
    result.elapsed = chrono::duration<double>{end-start}.count();

    return result;
}

// Prepare multithreaded use of sym_ellipsoid(). Each thread gets 1 octant
Result sym_ellipsoid_t(int N, mat const& A, const vector<double>& InvD, double r, unsigned int nr_threads) {
    nr_threads = pow(2, ceil(log2(nr_threads)));

    vector<future<Result>> results;
    for (auto i=nr_threads+1; i<2*nr_threads; ++i)
        results.emplace_back(async(launch::async, sym_ellipsoid, N, ref(A), ref(InvD), r, i));
    auto result = sym_ellipsoid(N, A, InvD, r, nr_threads);
    for (auto i=0U; i<nr_threads-1; ++i) result += results[i].get();
    return result;
}

int main(int argc, char* const* argv) {
    cin.exceptions(ios::failbit | ios::badbit);
    cout.precision(12);

    double epsilon    = EPSILON; // Target absolute error
    bool inv_modular  = true;    // Use modular transform to get the best matrix
    bool lat_reduce   = true;    // Use lattice reduction to align the ellipsoid
    bool conservative = false;   // Use provable error bound instead of a guess
    bool eigen_values = false;   // Show eigenvalues
    int  threads_max  = thread::hardware_concurrency();

    int option_char;
    while ((option_char = getopt(argc, argv, "p:n:MRce")) != EOF)
        switch (option_char) {
            case 'p': epsilon      = atof(optarg); break;
            case 'n': threads_max  = atoi(optarg); break;
            case 'M': inv_modular  = false;        break;
            case 'R': lat_reduce   = false;        break;
            case 'c': conservative = true;         break;
            case 'e': eigen_values = true;         break;
            default:
              cerr << "usage: " << argv[0] << " [-p epsilon] [-n threads] [-M] [-R] [-e] [-c]" << endl;
              exit(EXIT_FAILURE);
        }
    if (optind < argc) {
        cerr << "Unexpected argument" << endl;
        exit(EXIT_FAILURE);
    }
    if (threads_max < 1) threads_max = 1;
    threads_max = pow(2, ceil(log2(threads_max)));
    cout << "Using up to " << threads_max << " threads" << endl;

    int N;
    cin >> N;

    mat P(N, N);
    for (auto& v: P) cin >> v;

    if (eigen_values) {
        vec eigval = eig_sym(P);
        cout << "Eigenvalues:\n" << eigval << endl;
    }

    // Decompose P = A * A.t()
    mat A = chol(P, "lower");

    // Calculate lattice determinant
    double lat_det = 1;
    for (auto i=0; i<N; ++i) {
        if (A(i,i) <= 0) throw(logic_error("Diagonal not Positive"));
        lat_det *= A(i,i);
    }
    cout << "Lattice determinant=" << lat_det << endl;

    auto factor = lat_det / pow(M_PI, N/2.0);
    if (inv_modular && factor < 1) {
        epsilon *= factor;
        cout << "Lattice determinant is small. Using inverse instead. Factor=" << factor << endl;
        P = M_PI * M_PI * inv(P);
        A = chol(P, "lower");
        // We could simple calculate the new lat_det as pow(M_PI,N)/lat_det
        lat_det = 1;
        for (auto i=0; i<N; ++i) {
            if (A(i,i) <= 0) throw(logic_error("Diagonal not Positive"));
            lat_det *= A(i,i);
        }
        cout << "New lattice determinant=" << lat_det << endl;
    } else
        factor = 1;

    // Prepare for lattice reduction.
    // Since the library works on integer lattices we will scale up our matrix
    double min = INFINITY;
    for (auto i=0; i<N; ++i) {
        for (auto j=0; j<N;++j)
            if (A(i,j) != 0 && abs(A(i,j) < min)) min = abs(A(i,j));
    }

    auto upscale = UPSCALE/min;
    mat_ZZ a;
    a.SetDims(N,N);
    for (auto i=0; i<N; ++i)
        for (auto j=0; j<N;++j) a[i][j] = to_ZZ(A(i,j)*upscale);

    // Finally do the actual lattice reduction
    mat_ZZ u;
    auto rank = G_BKZ_FP(a, u);
    if (rank != N) throw(logic_error("Matrix is singular"));
    mat U(N,N);
    for (auto i=0; i<N;++i)
        for (auto j=0; j<N;++j) U(i,j) = to_double(u[i][j]);

    // There should now be a short lattice vector at row 0
    ZZ sum = to_ZZ(0);
    for (auto j=0; j<N;++j) sum += a[0][j]*a[0][j];
    auto rho = sqrt(to_double(sum))/upscale;
    cout << "Rho=" << rho << " (integer square " <<
        rho*rho << " ~ " <<
        static_cast<int>(rho*rho+0.5) << ")" << endl;

    // Lattice reduction doesn't gain us anything conceptually.
    // The same number of points is evaluated for the same exponential values
    // However working through the ellipsoid dimensions from large lattice
    // base vectors to small makes ellipsoid() a *lot* faster
    if (lat_reduce) {
        mat B = U * A;
        P = B * B.t();
        A = chol(P, "lower");
        if (eigen_values) {
            vec eigval = eig_sym(P);
            cout << "New eigenvalues:\n" << eigval << endl;
        }
    }

    vector<double> InvD(N);;
    for (auto i=0; i<N; ++i) InvD[i] = 1 / A(i, i);

    // Calculate radius needed for target precision
    auto r = radius(N, rho, lat_det, epsilon);
    cout << "Safe R=" << r << endl;

    auto nr_threads = threads_max;
    Result result;
    if (conservative) {
        // Walk all points inside the ellipsoid with transformed radius r
        result = sym_ellipsoid_t(N, A, InvD, r, nr_threads);
    } else {
        // First grow the radius until we saw POINTS_MIN points or reach the
        // target radius
        double i = floor(N * log2(r/rho) / log2(GROW));
        if (i < 0) i = 0;
        auto R = r * pow(GROW, -i/N);
        cout << "Initial R=" << R << endl;
        result = sym_ellipsoid_t(N, A, InvD, R, nr_threads);
        nr_threads = result.elapsed < THREAD_SEC ? 1 : threads_max;
        auto max_new_points = result.points;
        while (--i >= 0 && result.points < POINTS_MIN) {
            R = r * pow(GROW, -i/N);
            auto change = result;
            result = sym_ellipsoid_t(N, A, InvD, R, nr_threads);
            nr_threads = result.elapsed < THREAD_SEC ? 1 : threads_max;
            change = result - change;

            if (change.points > max_new_points) max_new_points = change.points;
        }

        // Now we have enough points that it's worth bothering to use threads
        while (--i >= 0) {
            R = r * pow(GROW, -i/N);
            auto change = result;
            result = sym_ellipsoid_t(N, A, InvD, R, nr_threads);
            nr_threads = result.elapsed < THREAD_SEC ? 1 : threads_max;
            change = result - change;
            // This is probably too crude and might misestimate the error
            // I've never seen it fail though
            if (change.points > max_new_points) {
                max_new_points = change.points;
                if (change.sum < epsilon/2) break;
            }
        }
        cout << "Final R=" << R << endl;
    }

    // We calculated half the points and skipped 0.
    result.sum = 2*result.sum+1;

    // Modular transform factor
    result.sum /= factor;

    // Report result
    cout <<
        "Evaluated " << result.points << " points\n" <<
        "Sum = " << result.sum << endl;
}

यह मेरे विचार में बहुत ही प्रभावशाली और बहुत अच्छा है। मैं प्रलेखन के लिए तत्पर हूं :)

1
@ टोनहोस क्या आप हमें कुछ और बता सकते हैं कि आप कैसे सीमा के साथ आते हैं?
18

2
मैं आर्क लिनक्स का उपयोग कर रहा हूं और -lgslcblasसंकलन करने के लिए ध्वज की आवश्यकता है । वैसे अद्भुत जवाब!
रिहाजोमैटिक

2

अजगर ३

मेरे कंप्यूटर पर 12 सेकंड n = 8, ubuntu 4 कोर।

वास्तव में अनुभवहीन, कोई सुराग नहीं है कि मैं क्या कर रहा हूं।

from itertools import product
from math import e

P = [[ 6., -3.,  3., -3.,  3.],
     [-3.,  6., -5.,  5., -5.],
     [ 3., -5.,  6., -5.,  5.],
     [-3.,  5., -5.,  6., -5.],
     [ 3., -5.,  5., -5.,  6.]]

N = 2

n = [1]

while e** -n[-1] > 0.0001:
    n = []
    for x in product(list(range(-N, N+1)), repeat = len(P)):
        n.append(sum(k[0] * k[1] for k in zip([sum(j[0] * j[1] for j in zip(i, x)) for i in P], x)))
    N += 1

print(sum(e** -i for i in n))

यह उस सीमा को बढ़ाता Zरहेगा जब तक कि यह एक अच्छा पर्याप्त जवाब न मिल जाए। मैंने अपनी खुद की मैट्रिक्स गुणा लिखा, विपुल रूप से खस्ता का उपयोग करना चाहिए।


धन्यवाद ! क्या आप अपने कंप्यूटर पर कुछ आउटपुट और टाइमिंग दिखा सकते हैं?

आपका कोड pypy में चलता है जो महान है और तेज है। दुर्भाग्य से, [[6.0, -1.0, -3.0, 1.0, 3.0, -1.0, -3.0, 1.0, 3.0], [-1.0, 6.0, -1.0, -5.0, 1.0, 5.0, -1.0, -5.0, 1.0 ], [-3.0, -1.0, 6.0, 1.0, -5.0, -1.0, 5.0, 1.0, -5.0], [1.0, -5.0, 1.0, 6.0, -1.0, -5.0, 1.0, 5.0, -1.0] , [3.0, 1.0, -5.0, -1.0, 6.0, 1.0, -5.0, -1.0, 5.0], [-1.0, 5.0, -1.0, -5.0, 1.0, 6.0, -1.0, -5.0, 1.0], [-3.0, -1.0, 5.0, 1.0, -5.0, -1.0, 6.0, 1.0, -5.0], [1.0, -5.0, 1.0, 5.0, -1.0, -5.0, 1.0, 6.0, -1.0], [ 3.0, 1.0, -5.0, -1.0, 5.0, 1.0, -5.0, -1.0, 6.0]] सिर्फ गलत उत्तर देता है।

8.1443647932-8.14381938863 = 0.00054540457> 0.0001।

3
@Maltysen आपका कार्यक्रम केवल यह जाँचता है कि क्या अंतिम शब्द दिए गए सटीकता से छोटा है। लेकिन आपके द्वारा की गई त्रुटि कहीं अधिक बड़ी है, क्योंकि आपको त्रुटि के लिए अन्य सभी शर्तों के योग पर भी विचार करना होगा!
दोष
हमारी साइट का प्रयोग करके, आप स्वीकार करते हैं कि आपने हमारी Cookie Policy और निजता नीति को पढ़ और समझा लिया है।
Licensed under cc by-sa 3.0 with attribution required.